diff --git a/.github/workflows/R-CMD-check.yaml b/.github/workflows/R-CMD-check.yaml index 9c73ff4f..931c81bc 100644 --- a/.github/workflows/R-CMD-check.yaml +++ b/.github/workflows/R-CMD-check.yaml @@ -44,10 +44,10 @@ jobs: extra-packages: any::rcmdcheck needs: check -# - name: Get dev terra for dev pastclim -# if: matrix.config.os == 'macos-latest' || ${{ github.base_ref == 'dev' }} || ${{ github.ref_name == 'dev' }} -# run: install.packages('terra', repos='https://rspatial.r-universe.dev') -# shell: Rscript {0} + - name: Get dev terra for dev pastclim + if: matrix.config.os == 'macos-latest' || ${{ github.base_ref == 'dev' }} || ${{ github.ref_name == 'dev' }} + run: install.packages('terra', repos='https://rspatial.r-universe.dev') + shell: Rscript {0} - uses: r-lib/actions/check-r-package@v2 with: diff --git a/DESCRIPTION b/DESCRIPTION index eec8a3a7..12478cd6 100644 --- a/DESCRIPTION +++ b/DESCRIPTION @@ -1,7 +1,7 @@ Package: pastclim Type: Package Title: Manipulate Time Series of Palaeoclimate Reconstructions -Version: 1.2.4 +Version: 1.2.4.9006 Authors@R: c( person("Michela", "Leonardi", role = "aut"), person(c("Emily","Y."), "Hallet", role = "ctb"), @@ -26,18 +26,19 @@ RoxygenNote: 7.2.3 Roxygen: list(markdown = TRUE) Depends: R (>= 4.0.0), - methods, terra (>= 1.7.18) Imports: curl, + lubridate, + methods, ncdf4, utils Suggests: - rmarkdown, - knitr, - sf, - ggplot2, - testthat (>= 3.0.0), - spelling + rmarkdown, + knitr, + ggplot2, + sf, + testthat (>= 3.0.0), + spelling VignetteBuilder: knitr Config/testthat/edition: 3 diff --git a/NAMESPACE b/NAMESPACE index 9816ea6f..67eea80b 100644 --- a/NAMESPACE +++ b/NAMESPACE @@ -1,9 +1,11 @@ # Generated by roxygen2: do not edit by hand export("time_bp<-") +export(bioclim_vars) export(clean_data_path) export(climate_for_locations) export(climate_for_time_slice) +export(date2ybp) export(df_from_region_series) export(df_from_region_slice) export(distance_from_sea) @@ -15,24 +17,30 @@ export(get_downloaded_datasets) export(get_ice_mask) export(get_land_mask) export(get_mis_time_steps) +export(get_time_bp_steps) +export(get_time_ce_steps) export(get_time_steps) export(get_vars_for_dataset) export(is_region_series) +export(list_available_datasets) export(location_series) export(location_slice) +export(location_slice_from_region_series) export(region_series) export(region_slice) export(sample_region_series) export(sample_region_slice) export(set_data_path) -export(set_data_path_for_CRAN) export(slice_region_series) export(time_bp) export(time_series_for_locations) export(update_dataset_list) export(validate_nc) export(var_labels) +export(ybp2date) exportMethods("time_bp<-") +exportMethods(bioclim_vars) exportMethods(time_bp) import(methods) import(terra) +importFrom(methods,setGeneric) diff --git a/NEWS.md b/NEWS.md index 08f4f682..8f3c7733 100644 --- a/NEWS.md +++ b/NEWS.md @@ -1,18 +1,29 @@ +# development +* Add Barreto et al 2023 (based on PALEO-PGEM, covering the last 5 M years) +* Add all the WorldClim data (present, and future projections with multiple models +and emission scenarios). +* Change the units of Krapp et al 2021 to match those of other datasets. Also, fix +data duplication of some variables which has now also been fixed on the OSF repository +for that dataset. +* Improve `get_ice_mask()`, `get_land_mask()`, and `distance_from_sea()` to work + on series rather than just on slices. +* Speed up `region_*()` functions when subsetting the extent/cropping. + # pastclim 1.2.4 * Updates on how time is handled to stay in sync with changes in `terra`. # pastclim 1.2.3 -* Added lai to Krapp2021 (the variable is now also present in the original OSF +* Added *lai* to *Krapp2021* (the variable is now also present in the original OSF repository for that dataset). -* Change column names in data.frame returned by location_series to match - location_slice -* Allow for interpolation of nearest neighbours in location_series, and allow - for a buffer on estimates returned by the location_* functions. +* Change column names in `data.frame` returned by `location_series()` to match + `location_slice()` +* Allow for interpolation of nearest neighbours in `location_series()`, and allow + for a buffer on estimates returned by the `location_*()` functions. # pastclim 1.2.2 -* Update of Krapp2021 files to make them compatible with how terra now handles +* Update of *Krapp2021* files to make them compatible with how `terra` now handles time. Users will have to re-download datasets. Old files can be removed with - 'clean_data_path()' + `clean_data_path()` # pastclim 1.2.1 * Small updates for CRAN submission. @@ -34,9 +45,9 @@ still work, but will raise a warning that the functions are deprecated. * Remove the need for `pastclimData`, we now put any data in the user dir returned - by R>=4.0.0. This removes the need of re-downloading the data when upgrading R. + by `R>=4.0.0`. This removes the need of re-downloading the data when upgrading `R`. -* Add monthly variables to Beyer2020 and Krapp2021. +* Add monthly variables to *Beyer2020* and *Krapp2021*. # pastclim 1.0.1 diff --git a/R/bioclim_vars.R b/R/bioclim_vars.R new file mode 100644 index 00000000..ddddbb49 --- /dev/null +++ b/R/bioclim_vars.R @@ -0,0 +1,265 @@ +#' Compute bioclimatic variables +#' +#' Function to compute "bioclimatic" variables from +#' monthly average temperature and precipitation data. For modern data, +#' this variables are generally computed using min and maximum temperature, +#' but for many palaeoclimatic reconstructions only average temperature is +#' available. Most variables, with the exception of BIO02 and BIO03, can +#' be rephrased meaningfully in terms of mean temperature. +#' This function is a modified version of \code{predicts::bcvars}. +#' +#' The variables are: +#' * BIO01 = Annual Mean Temperature +#' * BIO04 = Temperature Seasonality (standard deviation x 100) +#' * BIO05 = Max Temperature of Warmest Month +#' * BIO06 = Min Temperature of Coldest Month +#' * BIO07 = Temperature Annual Range (P5-P6) +#' * BIO08 = Mean Temperature of Wettest Quarter +#' * BIO09 = Mean Temperature of Driest Quarter +#' * BIO10 = Mean Temperature of Warmest Quarter +#' * BIO11 = Mean Temperature of Coldest Quarter +#' * BIO12 = Annual Precipitation +#' * BIO13 = Precipitation of Wettest Month +#' * BIO14 = Precipitation of Driest Month +#' * BIO15 = Precipitation Seasonality (Coefficient of Variation) +#' * BIO16 = Precipitation of Wettest Quarter +#' * BIO17 = Precipitation of Driest Quarter +#' * BIO18 = Precipitation of Warmest Quarter +#' * BIO19 = Precipitation of Coldest Quarter +#' +#' These summary Bioclimatic variables are after: +#' +#' Nix, 1986. A biogeographic analysis of Australian elapid snakes. In: R. Longmore (ed.). +#' Atlas of elapid snakes of Australia. Australian Flora and Fauna Series 7. +#' Australian Government Publishing Service, Canberra. +#' +#' and expanded following the ANUCLIM manual +#' +#' +#' @param tavg monthly average temperatures +#' @param prec monthly precipitation +#' @param ... additional variables for specific methods +#' @returns the bioclim variables +#' @docType methods +#' @rdname bioclim_vars-methods +#' @importFrom methods setGeneric +#' @export + +methods::setGeneric("bioclim_vars", function(prec, tavg, ...) { + methods::standardGeneric("bioclim_vars") +}) + +#' @rdname bioclim_vars-methods +#' @export +methods::setMethod( + "bioclim_vars", signature(prec = "numeric", tavg = "numeric"), + function(prec, tavg) { + bioclim_vars(t(as.matrix(prec)), t(as.matrix(tavg))) + } +) + +#' @param filename filename where the raster can be stored. +#' @rdname bioclim_vars-methods +#' @export +methods::setMethod( + "bioclim_vars", signature(prec = "SpatRaster", tavg = "SpatRaster"), + function(prec, tavg, filename = "", ...) { + if (nlyr(prec) != 12) stop("nlyr(prec) is not 12") + if (nlyr(tavg) != 12) stop("nlyr(tavg) is not 12") + + + x <- c(prec, tavg) + readStart(x) + on.exit(readStop(x)) + nc <- ncol(x) + out <- rast(prec, nlyr = 17) + names(out) <- c( + "bio01", paste0("bio0", 4:9), + paste0("bio", 10:19) + ) + b <- writeStart(out, filename, ...) + for (i in 1:b$n) { + d <- readValues(x, b$row[i], b$nrows[i], 1, nc, TRUE, FALSE) + p <- bioclim_vars(d[, 1:12], d[, 13:24]) + writeValues(out, p, b$row[i], b$nrows[i]) + } + writeStop(out) + return(out) + } +) + + +#' @param filename filename where the raster can be stored. +#' @rdname bioclim_vars-methods +#' @export +methods::setMethod( + "bioclim_vars", signature(prec = "SpatRasterDataset", tavg = "SpatRasterDataset"), + function(prec, tavg, filename = "", ...) { + if (!all(is_region_series(prec), is_region_series(tavg))) { + "prec and tavg should be generated with region_series" + } + if (!all( + (nlyr(prec)[1] == nlyr(tavg)[1]), + (time_bp(prec[[1]]) == time_bp(tavg[[1]])) + )) { + stop("prec and tavg should have the same time steps") + } + time_slices <- time_bp(prec[[1]]) + # loop over the time slices + for (i in 1:length(time_slices)) { + prec_slice <- slice_region_series(prec, time_bp = time_slices[i]) + tavg_slice <- slice_region_series(tavg, time_bp = time_slices[i]) + biovars_slice <- bioclim_vars(prec_slice, tavg_slice) + # set times in years BP + time_bp(biovars_slice) <- rep(time_slices[i], terra::nlyr(biovars_slice)) + if (i == 1) { + biovars_list <- split(biovars_slice, f = 1:17) + } else { + for (x in 1:(terra::nlyr(biovars_slice))) { + biovars_list[[x]] <- c(biovars_list[[x]], biovars_slice[[x]]) + } + } + } + # return the variables as a SpatRasterDataset + bioclim_sds <- terra::sds(biovars_list) + names(bioclim_sds) <- c( + "bio01", paste0("bio0", 4:9), + paste0("bio", 10:19) + ) + varnames(bioclim_sds) <- c( + "bio01", paste0("bio0", 4:9), + paste0("bio", 10:19) + ) + return(bioclim_sds) + } +) + + +#' @rdname bioclim_vars-methods +#' @export +methods::setMethod( + "bioclim_vars", signature(prec = "matrix", tavg = "matrix"), + function(prec, tavg) { + if (nrow(prec) != nrow(tavg)) { + stop("prec and tavg should have same length") + } + + if (ncol(prec) != ncol(tavg)) { + stop("prec and tavg should have same number of variables (columns)") + } + + # can"t have missing values in a row + nas <- apply(prec, 1, function(x) { + any(is.na(x)) + }) + nas <- nas | apply(tavg, 1, function(x) { + any(is.na(x)) + }) + p <- matrix(nrow = nrow(prec), ncol = 17) + colnames(p) <- c( + "bio01", paste0("bio0", 4:9), + paste0("bio", 10:19) + ) + if (all(nas)) { + return(p) + } + + prec[nas, ] <- NA + tavg[nas, ] <- NA + + window <- function(x) { + lng <- length(x) + x <- c(x, x[1:3]) + m <- matrix(ncol = 3, nrow = lng) + for (i in 1:3) { + m[, i] <- x[i:(lng + i - 1)] + } + apply(m, MARGIN = 1, FUN = sum) + } + + # P1. Annual Mean Temperature + p[, "bio01"] <- apply(tavg, 1, mean) + # P4. Temperature Seasonality (standard deviation) + p[, "bio04"] <- 100 * apply(tavg, 1, stats::sd) + # P5. Max Temperature of Warmest Period + p[, "bio05"] <- apply(tavg, 1, max) + # P6. Min Temperature of Coldest Period + p[, "bio06"] <- apply(tavg, 1, min) + # P7. Temperature Annual Range (P5-P6) + p[, "bio07"] <- p[, "bio05"] - p[, "bio06"] + # P12. Annual Precipitation + p[, "bio12"] <- apply(prec, 1, sum) + # P13. Precipitation of Wettest Period + p[, "bio13"] <- apply(prec, 1, max) + # P14. Precipitation of Driest Period + p[, "bio14"] <- apply(prec, 1, min) + # P15. Precipitation Seasonality(Coefficient of Variation) + # the "1 +" is to avoid strange CVs for areas where mean rainfaill is < 1) + p[, "bio15"] <- apply(prec + 1, 1, .cv) + + # precip by quarter (3 months) + wet <- t(apply(prec, 1, window)) + # P16. Precipitation of Wettest Quarter + p[, "bio16"] <- apply(wet, 1, max) + # P17. Precipitation of Driest Quarter + p[, "bio17"] <- apply(wet, 1, min) + tmp <- t(apply(tavg, 1, window)) / 3 + + if (all(is.na(wet))) { + p[, "bio08"] <- NA + p[, "bio09"] <- NA + } else { + # P8. Mean Temperature of Wettest Quarter + wetqrt <- cbind(1:nrow(p), as.integer(apply(wet, 1, which.max))) + p[, "bio08"] <- tmp[wetqrt] + # P9. Mean Temperature of Driest Quarter + dryqrt <- cbind(1:nrow(p), as.integer(apply(wet, 1, which.min))) + p[, "bio09"] <- tmp[dryqrt] + } + # P10 Mean Temperature of Warmest Quarter + p[, "bio10"] <- apply(tmp, 1, max) + + # P11 Mean Temperature of Coldest Quarter + p[, "bio11"] <- apply(tmp, 1, min) + + if (all(is.na(tmp))) { + p[, "bio18"] <- NA + p[, "bio19"] <- NA + } else { + # P18. Precipitation of Warmest Quarter + hot <- cbind(1:nrow(p), as.integer(apply(tmp, 1, which.max))) + p[, "bio18"] <- wet[hot] + # P19. Precipitation of Coldest Quarter + cold <- cbind(1:nrow(p), as.integer(apply(tmp, 1, which.min))) + p[, "bio19"] <- wet[cold] + } + + return(p) + } +) + +#' Coefficient of variation (expressed as percentage) +#' +#' R function to compute the coefficient of variation +#' (expressed as a percentage). If there is only a single value, stats::sd = NA. +#' However, one could argue that cv =0; and NA may break the code that +#' receives it. The function returns 0 if the mean is close to zero. +#' +#' This is ODD: abs to avoid very small (or zero) mean with e.g. -5:5 +#' +#' @param x a vector of values +#' @returns the cv +#' @keywords internal + +.cv <- function(x) { + # m <- mean(abs(x)) + m <- mean(x) + if (is.na(m)) { + return(NA) + } + if (m == 0) { + return(0) + } else { + return(100 * stats::sd(x) / m) + } +} diff --git a/R/check_available_datasets.R b/R/check_available_datasets.R index 5ca18f13..17e55aa7 100644 --- a/R/check_available_datasets.R +++ b/R/check_available_datasets.R @@ -9,7 +9,7 @@ check_available_dataset <- function(dataset, include_custom = FALSE) { - available_datasets <- get_available_datasets() + available_datasets <- list_available_datasets() if (include_custom) { available_datasets <- c(available_datasets, "custom") } diff --git a/R/check_coords_names.R b/R/check_coords_names.R new file mode 100644 index 00000000..f49a380b --- /dev/null +++ b/R/check_coords_names.R @@ -0,0 +1,32 @@ +#' Check that we have a valid pair of coordinate names +#' +#' This internal function checks that coords (as passed to functions) is a valid +#' set of names, or, if NULL, that we have standard variable names in data +#' +#' @param data a data.frame containing the locations. +#' @param coords a vector of length two giving the names of the "x" and "y" +#' coordinates, of points is a data.frame and does not use standard names. +#' @return A vector of length 2 with the valid names, in the correct order +#' @keywords internal + +check_coords_names <- function(data, coords) { + if (is.null(coords)) { + valid_names <- list( + c("x", "y"), c("longitude", "latitude"), c("lon", "lat"), + c("X", "Y") + ) + } else { + valid_names <- list(coords) + } + # internal function to check that both x and y names are present + check_pair <- function(valid_names, var_names) { + all(!is.na(match(valid_names, var_names))) + } + # find if we have any pair + valid_pair <- which(unlist(lapply(valid_names, check_pair, names(data)))) + if (length(valid_pair) != 1) { + stop("There are no recognised coordinate columns, set their names with 'coords'") + } + + return(valid_names[[valid_pair]]) +} diff --git a/R/check_times.R b/R/check_times.R new file mode 100644 index 00000000..f470c220 --- /dev/null +++ b/R/check_times.R @@ -0,0 +1,34 @@ +#' Check multiple time variables +#' +#' Check that we only have one set of times +#' +#' @param time_bp times in bp +#' @param time_ce times in ce +#' @param allow_null boolean whether both can be NULL +#' @returns times in bp +#' @keywords internal + +check_time_vars <- function(time_bp, time_ce, allow_null = TRUE) { + if (all(!is.null(time_bp), !is.null(time_ce))) { + stop("both time_bp and time_ce were provide, the function can only accept one of the two") + } + if (all(is.null(time_bp), is.null(time_ce))) { + if (allow_null) { + return(NULL) + } else { + stop("either time_bp or time_ce should be provided") + } + } + if (is.null(time_ce)) { + return(time_bp) + } else { + # convert it to bp + if (inherits(time_ce, "list")) { + return(lapply(time_ce, function(x) { + x - 1950 + })) + } else { + return(time_ce - 1950) + } + } +} diff --git a/R/clean_data_path.R b/R/clean_data_path.R index 1e4a3556..a3640f8a 100644 --- a/R/clean_data_path.R +++ b/R/clean_data_path.R @@ -1,4 +1,4 @@ -#' Clean the data path +#' Clean the data path #' #' This function deletes old reconstructions that have been superseded in the #' data_path. It assumes that the only files in data_path are part of `pastclim` @@ -8,8 +8,8 @@ #' @returns TRUE if files are deleted successfully #' @export -clean_data_path <- function(ask=TRUE) { - if (is.null(get_data_path(silent=TRUE))){ +clean_data_path <- function(ask = TRUE) { + if (is.null(get_data_path(silent = TRUE))) { message("The data path has not been set yet; use set_data_path() first!") return(FALSE) } @@ -17,21 +17,31 @@ clean_data_path <- function(ask=TRUE) { # remove some exceptions (we should check if the dataset list is still # current or whether it has become obsolete) files_now <- files_now[!files_now %in% c("pastclim_dataset_list.csv")] - files_now <- files_now[!substr(files_now,1,2)=="wc"] - + # keep worldclim datasets + files_now <- files_now[!substr(files_now, 1, 2) == "wc"] + # keep etopo datasets + files_now <- files_now[!substr(files_now, 1, 5) == "etopo"] + # keep chelsa datasets + files_now <- files_now[!substr(files_now, 1, 6) == "chelsa"] + + possible_files <- unique(getOption("pastclim.dataset_list")$file_name) files_to_remove <- files_now[!files_now %in% possible_files] - if (length(files_to_remove)>0){ - if (ask){ - this_answer <- utils::menu(choices = c("yes","no"), - title = paste("The following files are obsolete:\n", - paste(files_to_remove,collapse = ", "), - "\n Do you want to delete them?")) + if (length(files_to_remove) > 0) { + if (ask) { + this_answer <- utils::menu( + choices = c("yes", "no"), + title = paste( + "The following files are obsolete:\n", + paste(files_to_remove, collapse = ", "), + "\n Do you want to delete them?" + ) + ) } else { # default to delete if we are not asking this_answer <- 1 } - if (this_answer==1){ - file.remove(file.path(get_data_path(),files_to_remove)) + if (this_answer == 1) { + file.remove(file.path(get_data_path(), files_to_remove)) } } else { message("Everything is up-to-date; no files need removing.") diff --git a/R/datasets_docs.R b/R/datasets_docs.R index 8ce8c46e..85eddb43 100644 --- a/R/datasets_docs.R +++ b/R/datasets_docs.R @@ -10,9 +10,9 @@ NULL #' Documentation for the Beyer2020 dataset #' -#' This dataset covers the last 120k years, at intervals of 1/2 k years, and a +#' This dataset covers the last 120k years, at intervals of 1/2 k years, and a #' resolution of 0.5 degrees in latitude and longitude. -#' +#' #' If you use this dataset, make sure to cite the original publication: #' #' Beyer, R.M., @@ -35,12 +35,12 @@ NULL #' \url{https://pubs.usgs.gov/ds/691/ds691.pdf} #' #' Changelog -#' -#' v1.1.0 Added monthly variables. Files can be downloaded from: +#' +#' v1.1.0 Added monthly variables. Files can be downloaded from: #' \url{https://zenodo.org/deposit/7062281} -#' +#' #' v1.0.0 Remove ice sheets and internal seas, and use correct formula for bio15. -#' Files can be downloaded from: +#' Files can be downloaded from: #' \doi{doi.org/10.6084/m9.figshare.19723405.v1} #' #' @@ -50,9 +50,12 @@ NULL #' Documentation for the Krapp2021 dataset #' -#' This dataset covers the last 800k years, at intervals of 1k years, and a +#' This dataset covers the last 800k years, at intervals of 1k years, and a #' resolution of 0.5 degrees in latitude and longitude. #' +#' The units of several variables have been changed to match what is used +#' in WorldClim. +#' #' If you use this dataset, make sure to cite the original publication: #' #' Krapp, M., Beyer, R.M., Edmundson, S.L. et al. A statistics-based @@ -66,14 +69,121 @@ NULL #' \url{https://pubs.usgs.gov/ds/691/ds691.pdf} #' #' Changelog -#' +#' +#' v1.4.0 Change units to match WorldClim. Fix variable duplication found +#' on earlier versions of the dataset. +#' #' v1.1.0 Added monthly variables. Files can be downloaded from: #' \url{https://zenodo.org/record/7065055} -#' -#' v1.0.0 Remove ice sheets and use correct formula for bio15. +#' +#' v1.0.0 Remove ice sheets and use correct formula for bio15. #' Files can be downloaded from: #' \doi{doi.org/10.6084/m9.figshare.19733680.v1} #' #' @name Krapp2021 NULL #> NULL + +#' Documentation for the WorldClim datasets +#' +#' WorldClim version 2.1 is a database of high spatial resolution global weather and +#' climate data, covering both the present and future projections. If you use this +#' dataset, make sure to cite the original publication: +#' +#' Fick, S.E. and R.J. Hijmans, 2017. WorldClim 2: new 1km spatial resolution +#' climate surfaces for global land areas. International Journal of Climatology 37 (12): 4302-4315. +#' \doi{doi.org/10.1002/joc.5086} +#' +#' **Present-day reconstructions** are based on the mean for the period 1970-2000, +#' and are available at multiple resolutions of +#' 10 arc-minutes, 5 arc-minutes, 2.5 arc-minute and 0.5 arc-minutes. The resolution +#' of interest can be obtained by changing the ending of the dataset name +#' *WorldClim_2.1_RESm*, e.g. *WorldClim_2.1_10m* or *WorldClim_2.1_5m* +#' (currently, only 10m and 5m are currently available in `pastclim`). In `pastclim`, the datasets are given +#' a date of 1985 CE (the mid-point of the period of interest), corresponding to +#' a time_bp of 35. There are 19 “bioclimatic” variables, as well as monthly +#' estimates for minimum, mean, and maximum temperature, and precipitation. +#' +#' **Future projections** are based on the models in CMIP6, downscaled and de-biased +#' using WorldClim 2.1 for the present as a baseline. Monthly values of minimum +#' temperature, maximum temperature, and precipitation, as well as 19 bioclimatic +#' variables were processed for +#' 23 global climate models (GCMs), and for four +#' Shared Socio-economic Pathways (SSPs): 126, 245, 370 and 585. Model and +#' SSP can be chosen by changing the ending of the dataset name +#' *WorldClim_2.1_GCM_SSP_RESm*. +#' +#' Available values for GCM are: "ACCESS-CM2", +#' "BCC-CSM2-MR", "CMCC-ESM2", "EC-Earth3-Veg", "FIO-ESM-2-0", +#' "GFDL-ESM4", "GISS-E2-1-G", "HadGEM3-GC31-LL", "INM-CM5-0", "IPSL-CM6A-LR", +#' "MIROC6", "MPI-ESM1-2-HR", "MRI-ESM2-0", and "UKESM1-0-LL". For SSP, use: "ssp126", +#' "ssp245", "ssp370", and "ssp585". RES takes the same values as for present reconstructions +#' (i.e. "10m", "5m", "2.5m", and "0.5m"). Example dataset names are +#' *WorldClim_2.1_ACCESS-CM2_ssp245_10m* and *WorldClim_2.1_MRI-ESM2-0_ssp370_5m* +#' +#' The dataset are averages over 20 year +#' periods (2021-2040, 2041-2060, 2061-2080, 2081-2100). +#' In `pastclim`, the midpoints of the periods (2030, 2050, 2070, 2090) are used as the time stamps. All 4 periods +#' are automatically downloaded for each combination of GCM model and SSP, and are selected +#' as usual by defining the time in functions such as [region_slice()]. +#' +#' +#' @name WorldClim_2.1 +NULL +#> NULL + +#' Documentation for the WorldClim dataset at 10 arc-minute resolution +#' +#' @rdname WorldClim_2.1 +#' @name WorldClim_2.1_10m +NULL +#> NULL + +#' Documentation for the WorldClim dataset at 5 arc-minute resolution +#' +#' @rdname WorldClim_2.1 +#' @name WorldClim_2.1_5m +NULL +#> NULL + +#' Documentation for the Barreto et al 2023 dataset +#' +#' Spatio-temporal series of monthly temperature and precipitation and 17 +#' derived bioclimatic variables covering the last 5 Ma (Pliocene–Pleistocene), +#' at intervals of 1,000 years, and a spatial resolution of 1 +#' arc-degrees (see Barreto et al., 2023 for details). +#' +#' PALEO-PGEM-Series is downscaled to 1 × 1 arc-degrees spatial resolution from the +#' outputs of the PALEO-PGEM emulator (Holden et al., 2019), which emulates +#' reasonable and extensively validated global estimates of monthly temperature +#' and precipitation for the Plio-Pleistocene every 1 kyr at a spatial +#' resolution of ~5 × 5 arc-degrees (Holden et al., 2016, 2019). +#' +#' PALEO-PGEM-Series includes the mean and the standard deviation (i.e., +#' standard error) of the emulated climate over 10 stochastic GCM emulations +#' to accommodate aspects of model uncertainty. This allows users to estimate +#' the robustness of their results in the face of the stochastic aspects of +#' the emulations. For more details, see Section 2.4 in Barreto et al. (2023). +#' +#' Note that this is a very large dataset, with 5001 time slices. It takes +#' approximately 1 minute to set up each variable when creating a region_slice or +#' region_series. However, once the object has been created, other operations tend +#' to be much faster (especially if you subset the dataset to a small number +#' of time steps of interest). +#' +#' If you use this dataset, make sure to cite the original publications: +#' +#' Barreto, E., Holden, P. B., Edwards, N. R., & Rangel, T. F. (2023). +#' PALEO-PGEM-Series: A spatial time series of the global climate over the +#' last 5 million years (Plio-Pleistocene). Global Ecology and +#' Biogeography, 32, 1034-1045, +#' \doi{doi.org/10.1111/geb.13683} +#' +#' Holden, P. B., Edwards, N. R., Rangel, T. F., Pereira, E. B., Tran, G. T., +#' and Wilkinson, R. D. (2019): PALEO-PGEM v1.0: a statistical emulator of +#' Pliocene–Pleistocene climate, Geosci. Model Dev., 12, 5137–5155, +#' \doi{doi.org/10.5194/gmd-12-5137-2019}. +#' +#' @name Barreto2023 +NULL +#> NULL diff --git a/R/df_from_region_series.R b/R/df_from_region_series.R index 3b58ea4c..5253c9ca 100644 --- a/R/df_from_region_series.R +++ b/R/df_from_region_series.R @@ -1,28 +1,28 @@ #' Extract data frame from a region series -#' +#' #' Extract the climatic information from a region series and organise them as #' a data frame. -#' +#' #' To extract a data frame from a region slice, see [df_from_region_slice()]. #' #' @param x climate time series generated with [region_series()] -#' @param xy a boolean whether x and y coordinates should be added +#' @param xy a boolean whether x and y coordinates should be added #' to the dataframe (default to TRUE) #' @returns a data.frame where each cell each raster layer (i.e. timestep) is a #' row, and the available variables are columns. #' #' @export -df_from_region_series <- function(x ,xy=TRUE) { - if (!is_region_series(x)){ +df_from_region_series <- function(x, xy = TRUE) { + if (!is_region_series(x)) { stop("x is not a valid object generated by region_series") } times_all <- time_bp(x[[1]]) - for (i in seq_len(terra::nlyr(x[1]))){ - x_slice <- slice_region_series(x,times_all[i]) - slice_df <- terra::as.data.frame(x_slice,xy=xy) + for (i in seq_len(terra::nlyr(x[1]))) { + x_slice <- slice_region_series(x, times_all[i]) + slice_df <- terra::as.data.frame(x_slice, xy = xy) slice_df$time_bp <- times_all[i] - if (i==1){ + if (i == 1) { region_df <- slice_df } else { region_df <- rbind(region_df, slice_df) diff --git a/R/df_from_region_slice.R b/R/df_from_region_slice.R index d0045d3c..1fd01660 100644 --- a/R/df_from_region_slice.R +++ b/R/df_from_region_slice.R @@ -2,22 +2,22 @@ #' #' Extract the climatic information from a region slice and organise it as #' a data frame. This is just a wrapper around [terra::as.data.frame()]. -#' +#' #' To extract a data frame from a region series, see [df_from_region_series()]. #' -#' @param x climate time slice (i.e. a [`terra::SpatRaster`]) +#' @param x climate time slice (i.e. a [`terra::SpatRaster`]) #' generated with [region_slice()] -#' @param xy a boolean whether x and y coordinates should be added +#' @param xy a boolean whether x and y coordinates should be added #' to the dataframe (default to TRUE) #' @returns a data.frame where each cell the raster is a #' row, and the available variables are columns. #' #' @export -df_from_region_slice <- function(x ,xy=TRUE) { - if (!inherits(x,"SpatRaster")){ +df_from_region_slice <- function(x, xy = TRUE) { + if (!inherits(x, "SpatRaster")) { stop("x is not a valid SpatRaster generated by region_slice") } - slice_df <- terra::as.data.frame(x,xy=xy) + slice_df <- terra::as.data.frame(x, xy = xy) return(slice_df) } diff --git a/R/distance_from_sea.R b/R/distance_from_sea.R index f28b9dea..9b352cfa 100644 --- a/R/distance_from_sea.R +++ b/R/distance_from_sea.R @@ -4,25 +4,57 @@ #' from the sea for each land pixel. #' #' @param time_bp time slice in years before present (negative) +#' @param time_ce time slice in years CE. +#' Only one of `time_bp` or `time_ce` should be used. #' @param dataset string defining the dataset to use (a list of possible -#' values can be obtained with [get_available_datasets()]). This function +#' values can be obtained with [list_available_datasets()]). This function #' will not work on custom datasets. -#' @returns a [`terra::SpatRaster`] of distances +#' @returns a [`terra::SpatRaster`] of distances from the coastline in km #' #' @import terra #' @export -distance_from_sea <- function(time_bp, dataset) { - this_land_mask <- get_land_mask(time_bp=time_bp, - dataset=dataset) - coastlines_polyline <- terra::as.polygons(this_land_mask) # first get polygon - coastlines_polyline <- terra::as.lines(coastlines_polyline) # then extract line - - distances_rast <- terra::distance(this_land_mask$land_mask, - coastlines_polyline, - unit="km") - distances_rast <- terra::mask(distances_rast, this_land_mask) - names(distances_rast) <- "distance_from_sea" - - return(distances_rast) +distance_from_sea <- function(time_bp = NULL, time_ce = NULL, dataset) { + time_bp <- check_time_vars(time_bp = time_bp, time_ce = time_ce) + times <- get_time_bp_steps(dataset = dataset) + # if we don't give times, just use all available + if (is.null(time_bp)) { + time_bp <- times + } + # we use this to correctly convert time_bp + time_index <- time_bp_to_i_series( + time_bp = time_bp, + time_steps = times + ) + distances_list <- list() + for (i in 1:length(time_index)) { + this_time <- times[time_index[i]] + this_land_mask <- get_land_mask( + time_bp = this_time, + dataset = dataset + ) + coastlines_with_ice <- region_slice( + time_bp = this_time, + bio_variables = "biome", + dataset = dataset + ) + coastlines_with_ice[coastlines_with_ice > -1] <- 1 + coastlines_polyline <- terra::as.polygons(coastlines_with_ice) # first get polygon + coastlines_polyline <- terra::as.lines(coastlines_polyline) # then extract line + + distances_rast <- terra::distance(this_land_mask[[1]], + coastlines_polyline, + unit = "km" + ) + distances_rast <- terra::mask(distances_rast, this_land_mask) + # browser() + names(distances_rast) <- paste("distance_from_sea", time_bp(distances_rast), sep = "_") + if (i == 1) { + distances_all <- distances_rast + } else { + distances_all <- c(distances_all, distances_rast) + } + } + varnames(distances_all) <- "distance_from_sea" + return(distances_all) } diff --git a/R/download_chelsa.R b/R/download_chelsa.R new file mode 100644 index 00000000..4aaf3a81 --- /dev/null +++ b/R/download_chelsa.R @@ -0,0 +1,52 @@ +#' Download the CHELSA modern observations. +#' +#' This function downloads monthly variables from the CHELSA 2.1 dataset. +#' These variables are saved in a format that can be read by +#' load_chelsa, and easily used for delta downscaling palaeoclimate +#' observations. +#' +#' Note that variables are named differently from WorldClim. "tas" is the mean +#' temperature ("tavg" in WorldClim), with "tasmax" and "tasmin" being equivalent +#' to "tmax" and "tmin". +#' +#' @param var character Valid variables names are "tas", "tasmax","tasmin", and +#' "prec". +#' @param path character. Path where to download the data to. If left NULL, the data +#' will be downloaded from the directory returned by [get_data_path()]. +#' @returns TRUE if the requested CHELSA variable was downloaded successfully. +#' +#' @keywords internal + +download_chelsa <- function(var, res, path = NULL, version = "2.1", ...) { + if (!var %in% c("tas", "tasmax", "taxmin", "prec")) { + stop('Valid variables names are "tas", "tasmax","tasmin", and "prec".') + } + + if (is.null(path)) { + path <- get_data_path() + } else { + if (!dir.exists(path)) { + stop("the provided path does not exist") + } + } + + month_values <- sprintf("%02d", 1:12) + chelsa_filenames <- paste("CHELSA", var, month_values, "1981-2010_V.2.1.tif", sep = "_") + chelsa_urls <- paste0( + "https://os.zhdk.cloud.switch.ch/envicloud/chelsa/chelsa_V2/GLOBAL/climatologies/1981-2010/tas/", + chelsa_filenames + ) + # create the destination directory if needed + dir.create(file.path(tempdir(), "chelsa", var), showWarnings = FALSE, recursive = TRUE) + # download the files + curl::multi_download(chelsa_urls, + destfile = file.path(tempdir(), "chelsa", var, chelsa_filenames) + ) + # combined them into a single raster object + combined_rast <- terra::rast(file.path(tempdir(), "chelsa", var, chelsa_filenames)) + # save it as netcdf file + chelsa_nc_name <- paste0("chelsa21_30sec_", var, ".nc") + terra::writeCDF(combined_rast, file.path(path, chelsa_nc_name), + compression = 9 + ) +} diff --git a/R/download_dataset.R b/R/download_dataset.R index 6590c972..1ec546fe 100644 --- a/R/download_dataset.R +++ b/R/download_dataset.R @@ -5,22 +5,26 @@ #' [get_data_path()] and changed with [set_data_path()] #' #' @param dataset string defining dataset to be downloaded (a list of possible -#' values can be obtained with [get_available_datasets()]). This function +#' values can be obtained with [list_available_datasets()]). This function #' will not work on custom datasets. #' @param bio_variables one or more variable names to be downloaded. If left -#' to NULL, all variables available for this dataset will be downloaded +#' to NULL, all variables available for this dataset will be downloaded (the +#' parameters `annual` and `monthly`, see below, define which types) +#' @param annual boolean to download annual variables +#' @param monthly boolean to download monthly variables #' @returns TRUE if the dataset(s) was downloaded correctly. #' #' @export -download_dataset <- function(dataset, bio_variables = NULL) { - +download_dataset <- function(dataset, bio_variables = NULL, annual = TRUE, + monthly = FALSE) { # check the dataset exists available_datasets <- unique(getOption("pastclim.dataset_list")$dataset) if (!dataset %in% available_datasets) { + cat("'dataset' must be one of ") + get_available_datasets() stop( - "'dataset' must be one of ", - paste(available_datasets, collapse = ", ") + "Invalid 'dataset', for a comprehensive list of all possible combinations, use `list_available_datasets()`" ) } @@ -29,7 +33,14 @@ download_dataset <- function(dataset, bio_variables = NULL) { getOption("pastclim.dataset_list")$variable[getOption("pastclim.dataset_list")$dataset == dataset] # if variable is null, donwload all possible variables if (is.null(bio_variables)) { - bio_variables <- available_variables + bio_variables <- getOption("pastclim.dataset_list")[getOption("pastclim.dataset_list")$dataset == dataset, ] + if (!monthly) { + bio_variables <- bio_variables[bio_variables$monthly == FALSE, ] + } + if (!annual) { + bio_variables <- bio_variables[bio_variables$monthly != FALSE, ] + } + bio_variables <- bio_variables$variable } if (!all(bio_variables %in% available_variables)) { @@ -44,15 +55,22 @@ download_dataset <- function(dataset, bio_variables = NULL) { ) } - # add biome to list of variables (we need it for generate landmask) - if (!"biome" %in% bio_variables) { + # if (dataset %in% c("Krapp2021", "Beyer2020", "Example")){ + # # add biome to list of variables (we need it to generate the landmask) + # if (!"biome" %in% bio_variables) { + # bio_variables <- c(bio_variables, "biome") + # } + # } + + # add biome to list of variables (we need it to generate the landmask) + if (all((!"biome" %in% bio_variables), ("biome" %in% available_variables))) { bio_variables <- c(bio_variables, "biome") } # special case for the example dataset # as we have a copy on the package - if (dataset == "Example"){ + if (dataset == "Example") { copy_example_data() } else { # download the file for each variable @@ -60,10 +78,17 @@ download_dataset <- function(dataset, bio_variables = NULL) { file_details <- get_file_for_dataset(this_var, dataset) # only download the file if it is needed if (!file.exists(file.path(get_data_path(), file_details$file_name))) { - curl::curl_download(file_details$download_path, - destfile = file.path(get_data_path(), file_details$file_name), - quiet = FALSE - ) + # if it is a standard file to download + if (file_details$download_path != "") { + curl::curl_download(file_details$download_path, + destfile = file.path(get_data_path(), file_details$file_name), + quiet = FALSE + ) + } else { # we use a custom download function if the files have to be converted locally + eval(parse(text = file_details$download_function))(dataset = dataset, + bio_var = this_var, + filename = file.path(get_data_path(), file_details$file_name)) + } } } } diff --git a/R/download_etopo.R b/R/download_etopo.R new file mode 100644 index 00000000..11e61ed2 --- /dev/null +++ b/R/download_etopo.R @@ -0,0 +1,43 @@ +#' Download the ETOPO Global relief model +#' +#' This function downloads the ETOPO2022 global relief model at 30 or 60 arcsecs +#' resolution. This is a large file (>1Gb). +#' +#' @param path character. Path where to download the data to. If left NULL, the data +#' will be downloaded from the directory returned by [get_data_path()], and automatically +#' named "etopo2022_{resolution}s_v1.nc" +#' @param resolution numeric resolution in arcsecs (one of 30, or 60). +#' Defaults to 60 arcsecs. +#' @returns a dataframe produced by [curl::multi_download()] with information about +#' the download (including error codes) +#' +#' @keywords internal + +download_etopo <- function(path = NULL, resolution = 60) { + if (is.null(path)) { + path <- get_data_path() + } else { + if (!dir.exists(path)) { + stop("the provided path does not exist") + } + } + + if (resolution == 30) { + etopo_url <- "https://www.ngdc.noaa.gov/thredds/fileServer/global/ETOPO2022/30s/30s_bed_elev_netcdf/ETOPO_2022_v1_30s_N90W180_bed.nc" + } else if (resolution == 60) { + etopo_url <- "https://www.ngdc.noaa.gov/thredds/fileServer/global/ETOPO2022/60s/60s_bed_elev_netcdf/ETOPO_2022_v1_60s_N90W180_bed.nc" + } else { + stop("resolution should be one of 30 or 60 arc-secs") + } + + # download the files + res <- curl::multi_download(etopo_url, + destfile = file.path(path, paste0("etopo2022_", resolution, "s_v1.nc")) + ) + if (!res$success) { + warning("the download failed!") + } else { + message("the download was successul; access the relief data with `load_etopo()`") + } + res +} diff --git a/R/download_worldclim_future.R b/R/download_worldclim_future.R new file mode 100644 index 00000000..54a653ca --- /dev/null +++ b/R/download_worldclim_future.R @@ -0,0 +1,100 @@ +#' Download a WorldClim future predictions. +#' +#' This function downloads annual and monthly variables from the WorldClim 2.1 +#' predictions for the future. +#' @param dataset the name of the dataset +#' @param bio_var the variable name +#' @param filename the file name (full path) of the file to be saved +#' @returns TRUE if the requested WorldClim variable was downloaded successfully +#' +#' @keywords internal + +download_worldclim_future <- function(dataset, bio_var, filename) { + # reset warnings for gdal to terra default + # this is necessary if sf was loaded in the mean time + terra::gdal(warn = 3) + # get resolution from the dataset name and convert it to the original + res_conversion <- data.frame( + our_res = c("10m", "5m", "2.5m", "0.5m"), + wc_res = c("10m", "5m", "2.5m", "30s") + ) + wc_res <- res_conversion$wc_res[res_conversion$our_res == tail(strsplit(dataset, "_")[[1]], 1)] + gcm <- c( + "ACCESS-CM2", "BCC-CSM2-MR", "CMCC-ESM2", "EC-Earth3-Veg", "FIO-ESM-2-0", + "GFDL-ESM4", "GISS-E2-1-G", "HadGEM3-GC31-LL", "INM-CM5-0", "IPSL-CM6A-LR", + "MIROC6", "MPI-ESM1-2-HR", "MRI-ESM2-0", "UKESM1-0-LL" + ) + scenarios <- c("ssp126", "ssp245", "ssp370", "ssp585") + dates_df <- data.frame( + orig = c("2021-2040", "2041-2060", "2061-2080", "2081-2100"), + time_bp = (c(2030, 2050, 2070, 2090) - 1950) + ) + wc_gcm <- gcm[which(unlist(lapply(gcm, grepl, dataset)))] + wc_scenario <- scenarios[which(unlist(lapply(scenarios, grepl, dataset)))] + + # set appropriate postfix and prefix based on variable names + if (grepl("bio", bio_var)) { + postfix <- "bioc" + var_prefix <- "bio" + } else if (grepl("temperature_min", bio_var)) { + postfix <- "tmin" + var_prefix <- "temperature_min_" + } else if (grepl("temperature_max", bio_var)) { + postfix <- "tmax" + var_prefix <- "temperature_max_" + } else if (grepl("precipitation_", bio_var)) { + postfix <- "prec" + var_prefix <- "precipitation_" + } else if (grepl("altitude", bio_var)) { + # TODO this requires dispatching to a custom function that takes the elevation + # form the present, and then creates a special altitude file + postfix <- "elev" + var_prefix <- "elevation" + } + + base_url <- "https://geodata.ucdavis.edu/cmip6" + base_url <- paste(base_url, wc_res, wc_gcm, wc_scenario, sep = "/") + base_file <- paste("wc2.1", wc_res, postfix, wc_gcm, wc_scenario, sep = "_") + base_url <- paste(base_url, base_file, sep = "/") + # https://geodata.ucdavis.edu/cmip6/10m/ACCESS-CM2/ssp126/wc2.1_10m_tmin_ACCESS-CM2_ssp126_2081-2100.tif + + wc_list <- list() + for (i_step in dates_df$orig) { + this_url <- paste0(base_url, "_", i_step, ".tif") + destfile <- tempfile() + # download this zip file into a temp file + curl::curl_download(this_url, + destfile = destfile, + quiet = FALSE + ) + wc_list[[i_step]] <- terra::rast(destfile) + + message("this will take a few minutes") + # and finally we save it as a netcdf file + time_bp(wc_list[[i_step]]) <- rep(dates_df$time_bp[dates_df$orig == i_step], nlyr(wc_list[[i_step]])) + } + message("assembling all the data into a netcdf file for use with pastclim; this operation will take a few minutes...\n") + + var_names <- names(wc_list[[1]]) + sds_list <- list() + for (i in 1:length(var_names)) { + i_var <- var_names[i] + if (!any(postfix %in% c("bioc", "elev"))) { + new_var_name <- paste0(var_prefix, sprintf("%02d", i)) + } else { + new_var_name <- i_var + } + sds_list[[new_var_name]] <- terra::rast(lapply(wc_list, terra::subset, subset = i_var)) + names(sds_list[[new_var_name]]) <- rep(new_var_name, nlyr((sds_list[[new_var_name]]))) + } + wc_sds <- terra::sds(sds_list) + + terra::writeCDF(wc_sds, + filename = filename, compression = 9, + overwrite = TRUE + ) + # fix time axis (this is a workaround if we open the file with sf) + nc_in <- ncdf4::nc_open(filename, write = TRUE) + ncdf4::ncatt_put(nc_in, varid = "time", attname = "axis", attval = "T") + ncdf4::nc_close(nc_in) +} diff --git a/R/download_worldclim_present.R b/R/download_worldclim_present.R new file mode 100644 index 00000000..5df9afc6 --- /dev/null +++ b/R/download_worldclim_present.R @@ -0,0 +1,94 @@ +#' Download a WorldClim modern observations. +#' +#' This function downloads annual and monthly variables from the WorldClim 2.1 dataset. +#' @param dataset the name of the dataset +#' @param bio_var the variable name +#' @param filename the file name (full path) of the file to be saved +#' @returns TRUE if the requested WorldClim variable was downloaded successfully +#' +#' @keywords internal + +download_worldclim_present <- function(dataset, bio_var, filename) { + # reset warnings for gdal to terra default + # this is necessary if sf was loaded in the mean time + terra::gdal(warn = 3) + + # get resolution from the dataset name and convert it to the original + res_conversion <- data.frame( + our_res = c("10m", "5m", "2.5m", "0.5m"), + wc_res = c("10m", "5m", "2.5m", "30s") + ) + wc_res <- res_conversion$wc_res[res_conversion$our_res == substr(dataset, + start = 15, + stop = nchar(dataset) + )] + + # function to grab the number from the raster layer + if (grepl("bio", bio_var)) { + postfix <- "bio.zip" + var_prefix <- "bio" + } else if (grepl("temperature_min", bio_var)) { + postfix <- "tmin.zip" + var_prefix <- "temperature_min_" + } else if (grepl("temperature_max", bio_var)) { + postfix <- "tmax.zip" + var_prefix <- "temperature_max_" + } else if (grepl("temperature_", bio_var)) { + postfix <- "tavg.zip" + var_prefix <- "temperature_" + } else if (grepl("precipitation_", bio_var)) { + postfix <- "prec.zip" + var_prefix <- "precipitation_" + } else if (grepl("altitude", bio_var)) { + postfix <- "elev.zip" + var_prefix <- "elevation" + } + + base_url <- "https://biogeo.ucdavis.edu/data/worldclim/v2.1/base/wc2.1" + full_url <- paste(base_url, wc_res, postfix, sep = "_") + destfile <- tempfile() + # download this zip file into a temp file + curl::curl_download(full_url, + destfile = destfile, + quiet = FALSE + ) + + # unzip it to a temporary directory + destpath <- file.path(tempdir(), "to_unzip") + utils::unzip(destfile, exdir = destpath) + wc_rast <- terra::rast(dir(destpath, pattern = ".tif", full.names = TRUE)) + # sort out variable names + if (!(grepl("altitude", bio_var))) { + # digits at the end of the name are the key identifier of each variable + digits_at_end <- sprintf( + "%02d", + as.numeric(substr( + names(wc_rast), + regexpr("_\\d+\\b", names(wc_rast)) + 1, + nchar(names(wc_rast)) + )) + ) + + # now we need to rename the layers + names(wc_rast) <- + paste0(var_prefix, digits_at_end) + } else { + names(wc_rast) <- "altitude" + } + + # and finally we save it as a netcdf file + time_bp(wc_rast) <- rep(35, nlyr(wc_rast)) + + terra::writeCDF(wc_rast, + filename = filename, compression = 9, + split = TRUE, overwrite = TRUE + ) + + # fix time axis (this is a workaround if we open the file with sf) + nc_in <- ncdf4::nc_open(filename, write = TRUE) + ncdf4::ncatt_put(nc_in, varid = "time", attname = "axis", attval = "T") + ncdf4::nc_close(nc_in) + + # clean up + unlink(file.path(destpath, "*")) +} diff --git a/R/get_available_datasets.R b/R/get_available_datasets.R index 2bd65b0e..c1a541b8 100644 --- a/R/get_available_datasets.R +++ b/R/get_available_datasets.R @@ -1,11 +1,21 @@ #' Get the available datasets. #' -#' List the datasets available in pastclim. Most functions can also be +#' List the datasets available in pastclim, which can be passed to functions +#' in `pastclim` as values for the parameter `dataset`. Most functions can also be #' used on custom datasets by setting `dataset="custom"` #' +#' This function provides a user-friendly list, summarising the many datasets +#' available from WorldClim. A comprehensive list of all available datasets +#' can be obtained with [list_available_datasets]. +#' #' @returns a character vector of the available datasets #' @export get_available_datasets <- function() { - return(unique(as.character(getOption("pastclim.dataset_list")$dataset))) + all_datasets <- unique(as.character(getOption("pastclim.dataset_list")$dataset)) + all_datasets <- all_datasets[!grepl("WorldClim_2.1", all_datasets)] + print(all_datasets) + message('for present day reconstructions, use "WorldClim_2.1_RESm", where RES is an available resolution.') + message('for future predictions, use "WorldClim_2.1_GCM_SSP_RESm", where GCM is the GCM model, SSP is the Shared Societ-economic Pathways scenario.') + message('use help("WorldClim_2.1") for a list of available options') } diff --git a/R/get_biome_classes.R b/R/get_biome_classes.R index 48960990..b85ab6bb 100644 --- a/R/get_biome_classes.R +++ b/R/get_biome_classes.R @@ -4,7 +4,7 @@ #' for a given dataset. #' #' @param dataset string defining dataset to be downloaded (a list of possible -#' values can be obtained with [get_available_datasets()]). This function +#' values can be obtained with [list_available_datasets()]). This function #' will not work on custom datasets. #' @returns a data.frame with columns id and category. #' diff --git a/R/get_data_path.R b/R/get_data_path.R index eee0f5dd..db2aa2e0 100644 --- a/R/get_data_path.R +++ b/R/get_data_path.R @@ -1,32 +1,34 @@ #' Get the data path where climate reconstructions are stored #' #' This function returns the path where climate reconstructions are stored. -#' +#' #' The path is stored in an option for `pastclim` named `data_path`. If #' a configuration file was saved when using [set_data_path()], the path #' is retrieved from a file named "pastclim_data.txt", which -#' is found in the directory returned by +#' is found in the directory returned by #' `tools::R_user_dir("pastclim","config")` (i.e. #' the default configuration directory for the package as set in R >= 4.0). #' -#' @param silent boolean on whether a message is returned when data_path is +#' @param silent boolean on whether a message is returned when data_path is #' not set (i.e. equal to NULL) #' @returns the data path #' @export -get_data_path <- function(silent=FALSE) { +get_data_path <- function(silent = FALSE) { # if the package already initiliased if (!is.null(getOption("pastclim.data_path"))) { return(getOption("pastclim.data_path")) - } else { # get the info from the config file + } else { # get the info from the config file # if the path was not set yet, return a message if (!file.exists(file.path( tools::R_user_dir("pastclim", "config"), "pastclim_data.txt" ))) { if (!silent) { - message("A default data_path was not set for pastclim;\n", - "use `set_data_path()` to set it.") + message( + "A default data_path was not set for pastclim;\n", + "use `set_data_path()` to set it." + ) } return(NULL) } @@ -34,9 +36,11 @@ get_data_path <- function(silent=FALSE) { tools::R_user_dir("pastclim", "config"), "pastclim_data.txt" ))[1, 1] - if (!dir.exists(path_to_nc)){ - stop("The path ",path_to_nc," from the config file does not exist!\n", - "You can reset the path with `set_data_path`.") + if (!dir.exists(path_to_nc)) { + stop( + "The path ", path_to_nc, " from the config file does not exist!\n", + "You can reset the path with `set_data_path`." + ) } return(path_to_nc) } diff --git a/R/get_dataset_info.R b/R/get_dataset_info.R index 0cbbe6a6..18498166 100644 --- a/R/get_dataset_info.R +++ b/R/get_dataset_info.R @@ -2,16 +2,16 @@ #' #' This function provides full information about a given dataset. A full #' list of datasets available in pastclim can be obtained with -#' [get_available_datasets()] +#' [list_available_datasets()] #' #' @param dataset A dataset in pastclim #' @returns text describing the dataset #' @keywords internal get_dataset_info <- function(dataset) { - if (!dataset %in% get_available_datasets()){ - stop("The dataset is not available in pastclim") - } + # if (!dataset %in% list_available_datasets()){ + # stop("The dataset is not available in pastclim") + # } help_console(dataset) } @@ -22,30 +22,30 @@ get_dataset_info <- function(dataset) { #' from https://www.r-bloggers.com/2013/06/printing-r-help-files-in-the-console-or-in-knitr-documents/ #' @param topic The topic of the help #' @param format how the output should be formatted -#' @param which lines should be printed +#' @param lines which lines should be printed #' @param before string to be printed before the output #' @param after string to be printed after the output #' @returns text of the help file #' #' @keywords internal -help_console <- function(topic, format=c("text", "html", "latex"), - lines=NULL, before=NULL, after=NULL) { - format=match.arg(format) +help_console <- function(topic, format = c("text", "html", "latex"), + lines = NULL, before = NULL, after = NULL) { + format <- match.arg(format) if (!is.character(topic)) topic <- deparse(substitute(topic)) getHelpFile <- utils::getFromNamespace(".getHelpFile", "utils") - helpfile = getHelpFile(utils::help(topic)) - hs <- utils::capture.output(switch(format, - text=tools::Rd2txt(helpfile, - outputEncoding = "ASCII"), - html=tools::Rd2HTML(helpfile), - latex=tools::Rd2latex(helpfile) - ) - ) + helpfile <- getHelpFile(utils::help(topic)) + hs <- utils::capture.output(switch(format, + text = tools::Rd2txt(helpfile, + outputEncoding = "ASCII" + ), + html = tools::Rd2HTML(helpfile), + latex = tools::Rd2latex(helpfile) + )) # replace strange formatting of title - hs[substr(hs,1,2)=="_\b"]<- gsub("_\b","",hs[substr(hs,1,2)=="_\b"],fixed = TRUE) - if(!is.null(lines)) hs <- hs[lines] + hs[substr(hs, 1, 2) == "_\b"] <- gsub("_\b", "", hs[substr(hs, 1, 2) == "_\b"], fixed = TRUE) + if (!is.null(lines)) hs <- hs[lines] hs <- c(before, hs, after) - cat(hs, sep="\n") + cat(hs, sep = "\n") invisible(hs) -} \ No newline at end of file +} diff --git a/R/get_file_for_dataset.R b/R/get_file_for_dataset.R index 9935512f..c2b4af06 100644 --- a/R/get_file_for_dataset.R +++ b/R/get_file_for_dataset.R @@ -4,7 +4,7 @@ #' #' @param variable one or more variable names to be downloaded #' @param dataset string defining dataset to be downloaded (a list of possible -#' values can be obtained with [get_available_datasets()]). This function +#' values can be obtained with [list_available_datasets()]). This function #' will not work on custom datasets. #' @returns the filename for that variable and dataset diff --git a/R/get_ice_mask.R b/R/get_ice_mask.R index c6691334..6eb210b6 100644 --- a/R/get_ice_mask.R +++ b/R/get_ice_mask.R @@ -1,24 +1,42 @@ #' Get the ice mask for a dataset. #' -#' Get the ice mask for a dataset at a given time point. +#' Get the ice mask for a dataset, either for the whole series or for specific +#' time points. #' -#' @param time_bp time slice in years before present (negative) +#' @param time_bp time slices in years before present (negative values represent +#' time before present, positive values time in the future). This parameter can +#' be a vector of times (the slices need +#' to exist in the dataset), a list with a min and max element setting the +#' range of values, or left to NULL to retrieve all time steps. +#' To check which slices are available, you can use +#' [get_time_bp_steps()]. #' @param dataset string defining dataset to be downloaded (a list of possible -#' values can be obtained with [get_available_datasets()]). This function +#' values can be obtained with [list_available_datasets()]). This function #' will not work on custom datasets. #' @returns a binary [`terra::SpatRaster`] with the ice mask as 1s #' #' @import terra #' @export -get_ice_mask <- function(time_bp, dataset) { - climate_slice <- region_slice( - time_bp = time_bp, bio_variables = "biome", - dataset = dataset - ) - climate_slice$ice_mask <- climate_slice[names(climate_slice)] - climate_slice$ice_mask[climate_slice$ice_mask != 28] <- NA - climate_slice$ice_mask[climate_slice$ice_mask == 28] <- TRUE - climate_slice <- terra::subset(climate_slice, "ice_mask") - return(climate_slice) +get_ice_mask <- function(time_bp = NULL, dataset) { + if (!dataset %in% list_available_datasets()) { + stop( + "this function only works on the defaults datasets in pastclim\n", + "you can get a list with `list_available_datasets()`" + ) + } + if (dataset %in% c("Example", "Beyer2020", "Krapp2021")) { + climate_series <- region_series( + time_bp = time_bp, bio_variables = "biome", + dataset = dataset + ) + ice_mask <- climate_series["biome"] + ice_mask[ice_mask != 28] <- NA + ice_mask[ice_mask == 28] <- 1 + names(ice_mask) <- paste("ice_mask", time_bp(ice_mask), sep = "_") + varnames(ice_mask) <- "ice_mask" + return(ice_mask) + } else { + stop("ice masks are not available for this dataset") + } } diff --git a/R/get_land_mask.R b/R/get_land_mask.R index 8c5b11cf..b6240647 100644 --- a/R/get_land_mask.R +++ b/R/get_land_mask.R @@ -1,24 +1,61 @@ #' Get the land mask for a dataset. #' -#' Get the land mask for a dataset at a given time point. +#' Get the land mask for a dataset, either for the whole series or for specific +#' time points. #' -#' @param time_bp time slice in years before present (negative) +#' @param time_bp time slices in years before present (negative values represent +#' time before present, positive values time in the future). This parameter can +#' be a vector of times (the slices need +#' to exist in the dataset), a list with a min and max element setting the +#' range of values, or left to NULL to retrieve all time steps. +#' To check which slices are available, you can use +#' [get_time_bp_steps()]. +#' @param time_ce time in years CE as an alternative to `time_bp`.Only one of +#' `time_bp` or `time_ce` should be used. For available time slices in years CE, use +#' [get_time_ce_steps()]. #' @param dataset string defining dataset to be downloaded (a list of possible -#' values can be obtained with [get_available_datasets()]). This function +#' values can be obtained with [list_available_datasets()]). This function #' will not work on custom datasets. #' @returns a binary [`terra::SpatRaster`] with the land mask as 1s #' #' @import terra #' @export -get_land_mask <- function(time_bp, dataset) { - climate_slice <- region_slice( - time_bp = time_bp, bio_variables = "biome", - dataset = dataset - ) - climate_slice$land_mask <- climate_slice[names(climate_slice)] - climate_slice$land_mask[climate_slice$land_mask != 28] <- TRUE - climate_slice$land_mask[climate_slice$land_mask == 28] <- NA - climate_slice <- terra::subset(climate_slice, "land_mask") - return(climate_slice) +get_land_mask <- function(time_bp = NULL, time_ce = NULL, dataset) { + time_bp <- check_time_vars(time_bp = time_bp, time_ce = time_ce) + if (!dataset %in% list_available_datasets()) { + stop( + "this function only works on the defaults datasets in pastclim\n", + "you can get a list with `list_available_datasets()`" + ) + } + + if (dataset %in% c("Example", "Beyer2020", "Krapp2021")) { + climate_series <- region_series( + time_bp = time_bp, bio_variables = "biome", + dataset = dataset + ) + land_mask <- climate_series["biome"] + land_mask[land_mask < 0] <- NA + land_mask[land_mask != 28] <- 1 + land_mask[land_mask == 28] <- NA + } else if (grepl("WorldClim", dataset)) { + climate_series <- region_series( + time_bp = time_bp, + bio_variables = get_vars_for_dataset(dataset)[1], + dataset = dataset + ) + land_mask <- climate_series[[1]] + land_mask[!is.na(land_mask)] <- 1 + } else { + stop("no method yet for this dataset") + } + + if (is.null(time_ce)) { + names(land_mask) <- paste("land_mask", time_bp(land_mask), sep = "_") + } else { + names(land_mask) <- paste("land_mask", time(land_mask), sep = "_") + } + varnames(land_mask) <- "land_mask" + return(land_mask) } diff --git a/R/get_mis_time_steps.R b/R/get_mis_time_steps.R index 96104c96..98859f0d 100644 --- a/R/get_mis_time_steps.R +++ b/R/get_mis_time_steps.R @@ -5,7 +5,7 @@ #' @param mis string giving the mis; it must use the same spelling as used in #' [mis_boundaries] #' @param dataset string defining dataset to be downloaded (a list of possible -#' values can be obtained with [get_available_datasets()]). If set to +#' values can be obtained with [list_available_datasets()]). If set to #' "custom", then a single nc file is used from "path_to_nc" #' @param path_to_nc the path to the custom nc file containing the palaeoclimate #' reconstructions. All the variables of interest need to be included in @@ -19,7 +19,7 @@ get_mis_time_steps <- function(mis, dataset, path_to_nc = NULL) { stop("'mis' should be one of ", paste(mis_boundaries$mis, collapse = ",")) } - time_steps <- get_time_steps(dataset = dataset, path_to_nc = path_to_nc) + time_steps <- get_time_bp_steps(dataset = dataset, path_to_nc = path_to_nc) mis_time_steps <- time_steps[time_steps > (mis_boundaries[mis_boundaries$mis == mis, "start"] * 1000) & time_steps <= (mis_boundaries[mis_boundaries$mis == mis, "end"] * 1000)] diff --git a/R/get_sea_level.R b/R/get_sea_level.R new file mode 100644 index 00000000..252a9c5f --- /dev/null +++ b/R/get_sea_level.R @@ -0,0 +1,34 @@ +#' Get sea level estimate +#' +#' This function returns the estimated sea level from Spratt et al. 2016, using +#' the long PC1. Sea levels are from contemporary sea level (note that the original +#' data are with reference to the sea level during the Holocene ~5k year ago). +#' +#' @param time_bp the time of interest +#' @returns a vector of sea levels in meters from present level +#' +#' @keywords internal + + +get_sea_level <- function(time_bp) { + # get sea level from Spratt 2016 + sea_level_info <- utils::read.table(system.file("extdata/sea_level_spratt2016.txt", + package = "pastclim" + ), header = TRUE) + time_calkaBP <- -time_bp / 1000 + if (any(time_calkaBP < 0)) { + stop("this function only supports times in the past") + } + if (any(time_calkaBP > 798)) { + stop("the dataset of sea level reconstructions stops at 798ky BP") + } + ## TODO this is not safe, we should be getting the closest values + ## or even better interpolate + sea_level <- stats::approx( + x = sea_level_info$age_calkaBP, + y = sea_level_info$SeaLev_longPC1, + xout = time_calkaBP + )$y + sea_level <- sea_level - sea_level_info$SeaLev_longPC1[1] # rescale to have 0 for 0kBP + return(sea_level) +} diff --git a/R/get_time_steps.R b/R/get_time_steps.R index 0c6e6fa8..a3bcb431 100644 --- a/R/get_time_steps.R +++ b/R/get_time_steps.R @@ -1,27 +1,47 @@ #' Get time steps for a given dataset #' -#' Get the time steps (in time_bp) available in a given dataset. +#' Get the time steps (in time_bp or time_ce) available in a given dataset. #' #' @param dataset string defining dataset to be downloaded (a list of possible -#' values can be obtained with [get_available_datasets()]). If set to +#' values can be obtained with [list_available_datasets()]). If set to #' "custom", then a single nc file is used from "path_to_nc" #' @param path_to_nc the path to the custom nc file containing the palaeoclimate #' reconstructions. All the variables of interest need to be included in #' this file. -#' @returns a vector of time steps (in time_bp) +#' @returns a vector of time steps (in time_bp, or time_ce) #' #' @export -get_time_steps <- function(dataset, path_to_nc = NULL) { +get_time_bp_steps <- function(dataset, path_to_nc = NULL) { check_dataset_path(dataset = dataset, path_to_nc = path_to_nc) if (is.null(path_to_nc)) { # we get the first available file to get info for the dataset - possible_vars <- get_vars_for_dataset(dataset) + possible_vars <- get_vars_for_dataset(dataset, monthly = TRUE) this_file <- get_file_for_dataset(possible_vars[1], dataset)$file_name path_to_nc <- file.path(get_data_path(), this_file) } - climate_nc <- terra::rast(path_to_nc, subds=1) + climate_nc <- terra::rast(path_to_nc, subds = 1) return(time_bp(climate_nc)) } + +#' @rdname get_time_bp_steps +#' @export +get_time_ce_steps <- function(dataset, path_to_nc = NULL) { + get_time_bp_steps( + dataset = dataset, + path_to_nc = path_to_nc + ) + 1950 +} + + +#' @rdname get_time_bp_steps +#' @export +get_time_steps <- function(dataset, path_to_nc = NULL) { + warning("this function is deprecated, use `get_time_bp_steps()` instead") + get_time_bp_steps( + dataset = dataset, + path_to_nc = path_to_nc + ) +} diff --git a/R/get_vars_for_dataset.R b/R/get_vars_for_dataset.R index ff718617..a57265bd 100644 --- a/R/get_vars_for_dataset.R +++ b/R/get_vars_for_dataset.R @@ -6,45 +6,62 @@ #' different reconstructions. #' #' @param dataset string defining dataset to be downloaded (a list of possible -#' values can be obtained with [get_available_datasets()]). +#' values can be obtained with [list_available_datasets()]). #' @param path_to_nc the path to the custom nc file containing the palaeoclimate -#' reconstructions. +#' reconstructions. If a custom nc file is given, 'details', 'annual' and 'monthly' +#' are ignored #' @param details boolean determining whether the output should include information -#' including long names of variables and their units +#' including long names of variables and their units. +#' @param annual boolean to show annual variables +#' @param monthly boolean to show monthly variables #' @returns a vector of variable names #' #' @export -get_vars_for_dataset <- function(dataset, path_to_nc = NULL, details=FALSE) { - if (dataset!="custom"){ - if (!is.null(path_to_nc)){ +get_vars_for_dataset <- function(dataset, path_to_nc = NULL, details = FALSE, + annual = TRUE, monthly = FALSE) { + if (dataset != "custom") { + if (!is.null(path_to_nc)) { stop("path_to_nc should only be set for 'custom' dataset") } check_available_dataset(dataset) - if (!details){ - return(getOption("pastclim.dataset_list")$variable[getOption("pastclim.dataset_list")$dataset == dataset]) + variable_info <- getOption("pastclim.dataset_list")[getOption("pastclim.dataset_list")$dataset == dataset, ] + # select variable types + # if (!all(monthly, annual)){ + # variable_info <- variable_info[variable_info$monthly==monthly,] + # } + if (!monthly) { + variable_info <- variable_info[variable_info$monthly == FALSE, ] + } + if (!annual) { + variable_info <- variable_info[variable_info$monthly != FALSE, ] + } + if (!details) { + return(variable_info$variable) } else { - return(getOption("pastclim.dataset_list")[getOption("pastclim.dataset_list")$dataset == dataset, - c("variable","long_name", "units")]) + return(variable_info[, c("variable", "long_name", "units")]) } } else { - if (is.null(path_to_nc)){ + if (is.null(path_to_nc)) { stop("path_to_nc should be set for 'custom' dataset") } nc_in <- ncdf4::nc_open(path_to_nc) - if (!details){ + if (!details) { vars <- names(nc_in$var) ncdf4::nc_close(nc_in) return(names(nc_in$var)) } else { - get_detail <- function(x, attrib) {return(x[[attrib]])} - vars_details <- data.frame(variable = names(nc_in$var), - long_name = unlist(lapply(nc_in$var, get_detail, "longname")), - units = unlist(lapply(nc_in$var, get_detail, "units"))) + get_detail <- function(x, attrib) { + return(x[[attrib]]) + } + vars_details <- data.frame( + variable = names(nc_in$var), + long_name = unlist(lapply(nc_in$var, get_detail, "longname")), + units = unlist(lapply(nc_in$var, get_detail, "units")) + ) rownames(vars_details) <- NULL return(vars_details) } - } } @@ -59,12 +76,15 @@ get_vars_for_dataset <- function(dataset, path_to_nc = NULL, details=FALSE) { check_available_variable <- function(variable, dataset) { # check that the variable is available for this dataset - if (!all(variable %in% get_vars_for_dataset(dataset))) { - missing_variables <- variable[!variable %in% get_vars_for_dataset(dataset)] + if (!all(variable %in% get_vars_for_dataset(dataset, monthly = TRUE))) { + missing_variables <- variable[!variable %in% get_vars_for_dataset(dataset, + annual = TRUE, + monthly = TRUE + )] stop( paste(missing_variables, collapse = ", "), " not available for ", dataset, "; available variables are ", - paste(get_vars_for_dataset(dataset), collapse = ", ") + paste(get_vars_for_dataset(dataset, monthly = TRUE), collapse = ", ") ) } else { return(TRUE) diff --git a/R/is_region_series.R b/R/is_region_series.R index d2b6fd8a..5e5940d0 100644 --- a/R/is_region_series.R +++ b/R/is_region_series.R @@ -1,13 +1,14 @@ #' Check the object is a valid region series #' #' A region series is a [`terra::SpatRasterDataset`] for which each -#' sub-dataset is a variable, and all variables have the same number of +#' sub-dataset is a variable, and all variables have the same number of #' time steps. -#' -#' The standard test only checks that each SpatRaster has the same number of -#' layers. The more thorough test (obtained with strict=TRUE) actually checks -#' that all time steps are identical by comparing the result of -#' [terra::time()] applied to each variable +#' +#' The standard test only checks that all sub-datasets (each of which is a +#' [`terra::SpatRaster`]) have the same number of +#' layers. The more thorough test (obtained with *strict=TRUE*) actually checks +#' that all variables have the same identical time steps by comparing the result of +#' [terra::time()] applied to each variable. #' #' @param x a [`terra::SpatRasterDataset`] representing a time series of #' regional reconstructions obtained from [region_series()]. @@ -17,17 +18,18 @@ #' #' @export -is_region_series <- function (x, strict = FALSE) { - if (!inherits(x,"SpatRasterDataset")){ +is_region_series <- function(x, strict = FALSE) { + if (!inherits(x, "SpatRasterDataset")) { stop("x should be a SpatRasterDataset") } - if (!strict){ - return (length(unique(terra::nlyr(x)))==1) + if (!strict) { + return(length(unique(terra::nlyr(x))) == 1) } else { - all_times<-list() - for (i in terra::varnames(x)){ + all_times <- list() + for (i in terra::varnames(x)) { all_times[[i]] <- time_bp(x[i]) + # TODO we should check that each variable has years as its units } - return(length(unique(all_times))==1) + return(length(unique(all_times)) == 1) } } diff --git a/R/list_available_datasets.R b/R/list_available_datasets.R new file mode 100644 index 00000000..cba8af4a --- /dev/null +++ b/R/list_available_datasets.R @@ -0,0 +1,13 @@ +#' List all the available datasets. +#' +#' List the datasets available in pastclim. The list is comprehensive, +#' and includes all combinations of models and future scenarios for WorldClim. +#' For a more user-friendly list, use [get_available_datasets()]. Most functions can also be +#' used on custom datasets by setting `dataset="custom"` +#' +#' @returns a character vector of the available datasets +#' @export + +list_available_datasets <- function() { + return(unique(as.character(getOption("pastclim.dataset_list")$dataset))) +} diff --git a/R/load_dataset_list.R b/R/load_dataset_list.R index c08ae392..8bfa91be 100644 --- a/R/load_dataset_list.R +++ b/R/load_dataset_list.R @@ -3,7 +3,7 @@ #' This function returns a dataframe with the details for each variable #' available in every dataset. It defaults to the copy stored within the #' package, but it checks in case there is an updated version stored as -#' 'data_list.csv' in +#' 'dataset_list_included.csv' in #' `tools::R_user_dir("pastclim","config")`. If the latter is present, the last #' column, named 'dataset_list_v', provides the version of this table, and the #' most advanced table is used. @@ -12,12 +12,14 @@ #' @returns the dataset list #' @keywords internal -load_dataset_list <- function(on_cran=FALSE) { - if (!on_cran){ +load_dataset_list <- function(on_cran = FALSE) { + if (!on_cran) { config_dir <- tools::R_user_dir("pastclim", "config") } else { config_dir <- tempdir() } + # if there is a file in the config directory, check whether it is more recent + # than the default table in the package if (file.exists(file.path( config_dir, "dataset_list_included.csv" @@ -28,8 +30,10 @@ load_dataset_list <- function(on_cran=FALSE) { )) table_in_config$dataset <- as.factor(table_in_config$dataset) # we should check that the new table includes all the columns in the original file - if (utils::compareVersion(table_in_config$dataset_list_v[1], - dataset_list_included$dataset_list_v[1])==1){ + if (utils::compareVersion( + table_in_config$dataset_list_v[1], + dataset_list_included$dataset_list_v[1] + ) == 1) { # need to update return(table_in_config) } diff --git a/R/load_etopo.R b/R/load_etopo.R new file mode 100644 index 00000000..5792bb55 --- /dev/null +++ b/R/load_etopo.R @@ -0,0 +1,36 @@ +#' Load the ETOPO global relief +#' +#' This function loads previously downloaded ETOPO 2022 global relief dataset, at +#' 30 or 60 arcsec resolution. To save the variables in a compatible +#' format, use [download_etopo()]. +#' +#' The function assumes that the file name is *etopo2022_{resolution}s_v1.nc* +#' +#' @param path character. Path where the dataset is stored. If left NULL, the data +#' will be downloaded from the directory returned by [get_data_path()] +#' @param resolution numeric resolution in arcsecs (one of 30, or 60). +#' Defaults to 60 arcsecs. +#' @param version character or numeric. The ETOPO2022 version number. +#' Only "1" supported at the moment +#' @returns a [`terra::SpatRaster`] of relief +#' +#' @keywords internal + +load_etopo <- function(path = NULL, resolution = 60, version = "1") { + if (is.null(path)) { + path <- get_data_path() + } else { + if (!dir.exists(path)) { + stop("the provided path does not exist") + } + } + etopo_file_name <- paste0("etopo2022_", resolution, "s_", version, ".nc") + etopo_full_path <- file.path(path, etopo_file_name) + if (!file.exists(etopo_full_path)) { + stop(etopo_full_path, " does not exist; use download_etopo() to download it") + } + + etopo_rast <- terra::rast(etopo_full_path) + time_bp(etopo_rast) <- 0 + return(etopo_rast) +} diff --git a/R/location_series.R b/R/location_series.R index 7023c917..f99e482c 100644 --- a/R/location_series.R +++ b/R/location_series.R @@ -6,16 +6,23 @@ #' falls into the water for the reconstructions, you will have to amend the coordinates #' to put it more firmly on land. #' -#' @param x a data.frame with columns `longitude`, ranging -#' -180 to 180, and `latitude`, from -90 to 90 (and an optional `name`), -#' or a vector of cell numbers. +#' @param x a data.frame with columns of x and y coordinates (and an optional `name` column), +#' or a vector of cell numbers. See `coords` for standard coordinate names, or +#' how to use custom ones. #' @param time_bp time slices in years before present (negative values represent #' time before present, positive values time in the future). This parameter can #' be a vector of times (the slices need #' to exist in the dataset), a list with a min and max element setting the #' range of values, or left to NULL to retrieve all time steps. #' To check which slices are available, you can use -#' [get_time_steps()]. +#' [get_time_bp_steps()]. +#' @param time_ce time slice in years CE (see `time_bp` for options). +#' For available time slices in years CE, use [get_time_ce_steps()]. +#' Only one of `time_bp` or `time_ce` should be used. +#' @param coords a vector of length two giving the names of the "x" and "y" +#' coordinates, as found in `data`. If left to NULL, the function will +#' try to guess the columns based on standard names `c("x", "y")`, `c("X","Y")`, +#' `c("longitude", "latitude")`, or `c("lon", "lat")` #' @param bio_variables vector of names of variables to be extracted. #' @param dataset string defining the dataset to use. If set to "custom", #' then a single nc file is used from "path_to_nc" @@ -35,8 +42,8 @@ #' locations that are in cells with an NA). The buffer size is determined #' by the argument `directions`. `buffer` defaults to FALSE. #' @param directions character or matrix to indicate the directions in which -#' cells are considered connected when using `nn_interpol` or `buffer`. -#' The following character values are allowed: "rook" or "4" for the +#' cells are considered connected when using `nn_interpol` or `buffer`. +#' The following character values are allowed: "rook" or "4" for the #' horizontal and vertical neighbours; "bishop" to get the diagonal neighbours; #' "queen" or "8" to get the vertical, horizontal and diagonal neighbours; #' or "16" for knight and one-cell queen move neighbours. If directions @@ -47,27 +54,32 @@ location_series <- function(x, time_bp = NULL, + time_ce = NULL, + coords = NULL, bio_variables, dataset, path_to_nc = NULL, nn_interpol = FALSE, buffer = FALSE, directions = 8) { - + time_bp <- check_time_vars(time_bp = time_bp, time_ce = time_ce) + check_dataset_path(dataset = dataset, path_to_nc = path_to_nc) # if we are using standard datasets, check whether a variables exists # and get the times if (dataset != "custom") { check_var_downloaded(bio_variables, dataset) - times <- get_time_steps(dataset = dataset, path_to_nc = path_to_nc) + times <- get_time_bp_steps(dataset = dataset, path_to_nc = path_to_nc) } else { # else check that the variables exist in the custom nc check_var_in_nc(bio_variables, path_to_nc) - times <- get_time_steps(dataset = "custom", path_to_nc = path_to_nc) + times <- get_time_bp_steps(dataset = "custom", path_to_nc = path_to_nc) } - time_bp_i <- time_bp_to_i_series(time_bp = time_bp, - time_steps = times) - if (is.null(time_bp_i)){ + time_bp_i <- time_bp_to_i_series( + time_bp = time_bp, + time_steps = times + ) + if (is.null(time_bp_i)) { time_bp <- times } else { time_bp <- times[time_bp_i] @@ -75,33 +87,36 @@ location_series <- # check coordinates data frame if (inherits(x, "data.frame")) { - if (!all(c("longitude","latitude") %in% names(x))){ - stop ("x should be a dataframe with columns latitude and longitude") - } + coords <- check_coords_names(x, coords) + # if names does not exist, add it - if (!"name" %in% names(x)){ - x$name<-as.character(1:nrow(x)) + if (!"name" %in% names(x)) { + x$name <- as.character(1:nrow(x)) } - x <- x[,match(c("name","longitude", "latitude"), names(x))] + x <- x[, match(c("name", coords), names(x))] n_loc <- nrow(x) # now repeat it for each time step - x<- x[rep(1:nrow(x),length(time_bp)),] - - }else if (inherits(x, "numeric")){ + x <- x[rep(1:nrow(x), length(time_bp)), ] + } else if (inherits(x, "numeric")) { n_loc <- length(x) - x<- rep(x, length(time_bp)) + x <- rep(x, length(time_bp)) } else { - stop ("x should be either a data.frame or a numeric vector") + stop("x should be either a data.frame or a numeric vector") } - + # now copy over the times to match the coordinates - time_bp <- rep(time_bp, each=n_loc) + time_bp <- rep(time_bp, each = n_loc) # and now feed the info to location_slice - location_ts <- location_slice(x=x, time_bp = time_bp, bio_variables = bio_variables, - dataset= dataset, path_to_nc=path_to_nc, - nn_interpol = nn_interpol, buffer = buffer, - directions = directions) - return(location_ts[,!names(location_ts) %in% "time_bp_slice"]) + location_ts <- location_slice( + x = x, time_bp = time_bp, coords = coords, bio_variables = bio_variables, + dataset = dataset, path_to_nc = path_to_nc, + nn_interpol = nn_interpol, buffer = buffer, + directions = directions + ) + + # TODO if we had time_ce, we should convert back from time_bp + + return(location_ts[, !names(location_ts) %in% "time_bp_slice"]) } @@ -125,5 +140,3 @@ time_series_for_locations <- function(...) { # } location_series(...) } - - diff --git a/R/location_slice.R b/R/location_slice.R index 61a81d48..1fef8d2d 100644 --- a/R/location_slice.R +++ b/R/location_slice.R @@ -4,13 +4,21 @@ #' at the appropriate times (selecting the closest time slice available for the #' specific date associated with each location). #' -#' @param x a data.frame with columns `longitude`, ranging -#' -180 to 180, and `latitude`, from -90 to 90, plus optional -#' columns `time_bp` and `name`. Alternatively, a vector of cell numbers. +#' @param x a data.frame with columns x and y coordinates(see `coords` for +#' standard coordinate names, or +#' how to use custom ones), plus optional +#' columns `time_bp` or `time_ce` (depending on the units used) and +#' `name`. Alternatively, a vector of cell numbers. #' @param time_bp used if no `time_bp` column is present in `x`: the dates in #' years before present (negative #' values represent time before present, i.e. 1950, positive values time in the future) #' for each location. +#' @param time_ce time in years CE as an alternative to `time_bp`.Only one of +#' `time_bp` or `time_ce` should be used. +#' @param coords a vector of length two giving the names of the "x" and "y" +#' coordinates, as found in `data`. If left to NULL, the function will +#' try to guess the columns based on standard names `c("x", "y")`, `c("X","Y")`, +#' `c("longitude", "latitude")`, or `c("lon", "lat")` #' @param bio_variables vector of names of variables to be extracted. #' @param dataset string defining the dataset to use. If set to "custom", #' then a single nc file is used from "path_to_nc" @@ -29,8 +37,8 @@ #' locations that are in cells with an NA). The buffer size is determined #' by the argument `directions`. `buffer` defaults to FALSE. #' @param directions character or matrix to indicate the directions in which -#' cells are considered connected when using `nn_interpol` or `buffer`. -#' The following character values are allowed: "rook" or "4" for the +#' cells are considered connected when using `nn_interpol` or `buffer`. +#' The following character values are allowed: "rook" or "4" for the #' horizontal and vertical neighbours; "bishop" to get the diagonal neighbours; #' "queen" or "8" to get the vertical, horizontal and diagonal neighbours; #' or "16" for knight and one-cell queen move neighbours. If directions @@ -41,129 +49,31 @@ location_slice <- function(x, time_bp = NULL, + time_ce = NULL, + coords = NULL, bio_variables, dataset, path_to_nc = NULL, nn_interpol = TRUE, buffer = FALSE, directions = 8) { - - check_dataset_path(dataset = dataset, path_to_nc = path_to_nc) - - # if we are using standard datasets, check whether a variables exists - if (dataset != "custom") { - check_var_downloaded(bio_variables, dataset) - } else { # else check that the variables exist in the custom nc - check_var_in_nc(bio_variables, path_to_nc) - } - - # if we have a data.frame - if (inherits(x, "data.frame")){ - # check that we have coordinates - if (!all(c("longitude","latitude") %in% names(x))){ - stop("x must have columns latitude and longitude") - } - # check how time has been provided - if (("time_bp" %in% names(x)) & !is.null(time_bp)){ - stop("times should either be given as a column of x or as values for time_bp,", - "not both at the same time!") - } - if (!("time_bp" %in% names(x)) & is.null(time_bp)){ - stop("missing times: they should either be given as a column of x or as values for time_bp") - } - locations_data <- x - - } else if (inherits(x,"numeric")) { - locations_data <- data.frame(cell_number = x) - - } - # add time_bp if needed - if (!is.null(time_bp)){ - locations_data$time_bp <- time_bp - } - #reorder input by time - orig_id <- order(locations_data$time_bp) - locations_data <- locations_data[order(locations_data$time_bp), ] - time_indeces <- NULL - # store cooredinates in their own data.frame to be used for terra operations - if (inherits(x, "data.frame")){ - coords <- locations_data [,c("longitude","latitude")] - } else { - coords <- locations_data [,c("cell_number")] - } - - - for (this_var in bio_variables) { - # get name of file that contains this variable - if (dataset != "custom") { - this_file <- get_file_for_dataset(this_var, dataset)$file_name - this_file <- file.path(get_data_path(), this_file) - this_var_nc <- get_varname(variable = this_var, dataset = dataset) - } else { - this_file <- path_to_nc - this_var_nc <- this_var - } - if (is.null(time_indeces)) { - times <- get_time_steps(dataset = "custom", path_to_nc = this_file) - time_indeces <- time_bp_to_index( - time_bp = locations_data$time_bp, time_steps = times - ) - locations_data$time_bp_slice <- times[time_indeces] - unique_time_indeces <- unique(time_indeces) - } - - climate_brick <- terra::rast(this_file, subds = this_var_nc) - # create column to store variable - locations_data[this_var] <- NA - for (j in unique_time_indeces) { - this_slice <- terra::subset(climate_brick, j) - this_slice_indeces <- which(time_indeces == j) - if (!buffer){ # get the specific values for those locations - this_climate <- terra::extract( - x = this_slice, - y = coords[this_slice_indeces, ]) - locations_data[this_slice_indeces, this_var] <- this_climate[ - , - ncol(this_climate) - ] - } else { # set to NA as we will compute them with a buffer - locations_data[this_slice_indeces, this_var] <- NA - } - - if (nn_interpol | buffer) { - locations_to_move <- this_slice_indeces[this_slice_indeces %in% - which(is.na(locations_data[, this_var]))] - if (length(locations_to_move) == 0) { - next - } - for (i in locations_to_move) { - if (inherits(x, "data.frame")) { - cell_id <- - terra::cellFromXY(climate_brick, as.matrix(coords[ - i, - ])) - } else { - cell_id <- coords[i] - } - neighbours_ids <- - terra::adjacent(climate_brick, cell_id, - directions = directions, pairs = FALSE) - neighbours_values <- - terra::extract( - x = this_slice, - y = neighbours_ids[1, ] - )[, 1] - locations_data[i, this_var] <- - mean(neighbours_values, na.rm = T) - } - } - } - locations_data[is.nan(locations_data[, this_var]), this_var] <- - NA - } - locations_data <- locations_data[order(orig_id), ] - - return(locations_data) + # get the region series for this dataset + climate_brick <- region_series( + bio_variables = bio_variables, + dataset = dataset, + path_to_nc = path_to_nc + ) + # now simply wrap around location_slice_from_region_series + location_slice_from_region_series( + x = x, + time_bp = time_bp, + time_ce = time_ce, + coords = coords, + region_series = climate_brick, + nn_interpol = nn_interpol, + buffer = buffer, + directions = directions + ) } diff --git a/R/location_slice_from_region_series.R b/R/location_slice_from_region_series.R new file mode 100644 index 00000000..db384488 --- /dev/null +++ b/R/location_slice_from_region_series.R @@ -0,0 +1,233 @@ +#' Extract local climate for one or more locations for a given time slice. +#' +#' This function extract local climate for a set of locations +#' at the appropriate times (selecting the closest time slice available for the +#' specific date associated with each location). +#' +#' @param x a data.frame with columns x and y coordinates(see `coords` for +#' standard coordinate names, or +#' how to use custom ones), plus optional +#' columns `time_bp` or `time_ce` (depending on the units used) and +#' `name`. Alternatively, a vector of cell numbers. +#' @param time_bp used if no `time_bp` column is present in `x`: the dates in +#' years before present (negative +#' values represent time before present, i.e. 1950, positive values time in the future) +#' for each location. +#' @param time_ce time in years CE as an alternative to `time_bp`. Only one of +#' `time_bp` or `time_ce` should be used. +#' @param coords a vector of length two giving the names of the "x" and "y" +#' coordinates, as found in `data`. If left to NULL, the function will +#' try to guess the columns based on standard names `c("x", "y")`, `c("X","Y")`, +#' `c("longitude", "latitude")`, or `c("lon", "lat")` +#' @param region_series a [`SpatRasterDataset`] obtained with [region_series()] +#' @param nn_interpol boolean determining whether nearest neighbour +#' interpolation is used to estimate climate for cells that lack such +#' information (i.e. they are under water or ice). By default, interpolation is only +#' performed from the first ring of nearest neighbours; if climate is not +#' available, NA will be returned for that location. The number of neighbours +#' can be changed with the argument `directions`. `nn_interpol` defaults to TRUE. +#' @param buffer boolean determining whether the variable will be returned +#' as the mean of a buffer around the focal cell. If set to TRUE, it overrides +#' `nn_interpol` (which provides the same estimates as `buffer` but only for +#' locations that are in cells with an NA). The buffer size is determined +#' by the argument `directions`. `buffer` defaults to FALSE. +#' @param directions character or matrix to indicate the directions in which +#' cells are considered connected when using `nn_interpol` or `buffer`. +#' The following character values are allowed: "rook" or "4" for the +#' horizontal and vertical neighbours; "bishop" to get the diagonal neighbours; +#' "queen" or "8" to get the vertical, horizontal and diagonal neighbours; +#' or "16" for knight and one-cell queen move neighbours. If directions +#' is a matrix it should have odd dimensions and have logical (or 0, 1) values. +#' @returns a data.frame with the climatic variables of interest. +#' @export + +location_slice_from_region_series <- + function(x, + time_bp = NULL, + time_ce = NULL, + coords = NULL, + region_series, + nn_interpol = TRUE, + buffer = FALSE, + directions = 8) { + # get the region series for this dataset + climate_brick <- region_series + bio_variables <- names(region_series) + + time_bp <- check_time_vars(time_bp = time_bp, time_ce = time_ce) + readd_ce <- FALSE # boolean whether we will need to readd time_ce instead of time_bp + if (any(!is.null(time_ce), "time_ce" %in% names(x))) { + readd_ce <- TRUE + } + + # if we have a data.frame + if (inherits(x, "data.frame")) { + coords <- check_coords_names(x, coords) + + # check how time has been provided + # first make sure that, if there is a column, only one is provided + if (all(c("time_bp", "time_ce") %in% names(x))) { + stop("in x, there should only be either a 'time_bp' column, or a 'time_ce' column") + } + # check whether we have time both in the df and in the vector + if (all( + any(c("time_bp", "time_ce") %in% names(x)), + any(!is.null(time_bp), !is.null(time_ce)) + )) { + stop( + "times should either be given as a column of x, or as values for time_bp or time_ce,", + "not both at the same time!" + ) + } + # check if it is missing everywhere + if (all( + all(!c("time_bp", "time_ce") %in% names(x)), + all(is.null(time_bp), is.null(time_ce)) + )) { + stop("missing times: they should either be given as a column of x, or as values for time_bp or time_ce") + } + locations_data <- x + } else if (inherits(x, "numeric")) { + locations_data <- data.frame(cell_number = x) + } + # add time_bp if needed + if (!is.null(time_bp)) { + locations_data$time_bp <- time_bp + } + if ("time_ce" %in% names(locations_data)) { + locations_data$time_bp <- locations_data$time_ce - 1950 + } + + # reorder input by time + orig_id <- order(locations_data$time_bp) + locations_data <- locations_data[order(locations_data$time_bp), ] + time_indeces <- NULL + # store coordinates in their own data.frame to be used for terra operations + if (inherits(x, "data.frame")) { + coords_df <- locations_data[, coords] + } else { + coords_df <- locations_data[, c("cell_number")] + } + + + # now sort out the time slices corresponding to each location + times <- time_bp(climate_brick) + time_indeces <- time_bp_to_index( + time_bp = locations_data$time_bp, time_steps = times + ) + locations_data$time_bp_slice <- times[time_indeces] + unique_times <- unique(locations_data$time_bp_slice) + + for (i_time in unique_times) { + this_slice <- slice_region_series(climate_brick, + time_bp = i_time + ) + + this_slice_indeces <- which(locations_data$time_bp_slice == i_time) + if (!buffer) { # get the specific values for those locations + this_climate <- terra::extract( + x = this_slice, + y = locations_data[locations_data$time_bp_slice == i_time, coords] + ) + # sor tout the indexing here + locations_data[locations_data$time_bp_slice == i_time, bio_variables] <- + this_climate[ + , + bio_variables + ] + } else { # set to NA as we will compute them with a buffer + locations_data[this_slice_indeces, ] <- NA + } + + if (nn_interpol | buffer) { + locations_to_move <- this_slice_indeces[this_slice_indeces %in% + which(!stats::complete.cases(locations_data))] + if (length(locations_to_move) == 0) { + next + } + for (i in locations_to_move) { + if (inherits(x, "data.frame")) { + cell_id <- + terra::cellFromXY(this_slice, as.matrix(coords_df[ + i, + ])) + } else { + cell_id <- coords_df[i] + } + neighbours_ids <- + terra::adjacent(this_slice, cell_id, + directions = directions, pairs = FALSE + ) + + neighbours_values <- + terra::extract( + x = this_slice, + y = neighbours_ids[1, ] + ) # [, bio_variables] + + neighbours_values_mean <- apply(neighbours_values, 2, + mean, + na.rm = T + ) + if ("biome" %in% bio_variables) { + neighbours_values_mean["biome"] <- mode(neighbours_values[, "biome"]) + } + locations_data[i, bio_variables] <- + neighbours_values_mean[bio_variables] + } + } + } + # is.nan has not method for a data.frame + is.nan.data.frame <- function(x) { + do.call(cbind, lapply(x, is.nan)) + } + + locations_data[is.nan(locations_data)] <- NA + + locations_data <- locations_data[order(orig_id), ] + + if (readd_ce) { + locations_data$time_ce <- locations_data$time_bp + 1950 + locations_data$time_ce_slice <- locations_data$time_bp_slice + 1950 + locations_data <- locations_data[, !names(locations_data) %in% c("time_bp", "time_bp_slice")] + } + return(locations_data) + } + + +#' Extract local climate for one or more locations for a given time slice. +#' +#' Deprecated version of [location_slice()] +#' +#' @param ... arguments to be passed to [location_slice()] +#' @returns a data.frame with the climatic variables of interest +#' +#' @export + +climate_for_locations <- function(...) { + warning("DEPRECATED: use 'location_slice' instead") + # if (!is.null(path_to_nc)) { + # stop( + # "the use of pastclimData is now deprecated", + # "use 'set_path_data' instead" + # ) + # } + location_slice(...) +} + + +#' Mode +#' +#' Find the mode of vector x (note that, if multiple values have the same +#' frequency, this function simply picks the first occurring one) +#' +#' @param x a vector +#' @returns the mode +#' +#' @keywords internal + +mode <- function(x) { + x <- x[!is.na(x)] + ux <- unique(x) + ux[which.max(tabulate(match(x, ux)))] +} diff --git a/R/make_binary_mask.R b/R/make_binary_mask.R new file mode 100644 index 00000000..82eebca3 --- /dev/null +++ b/R/make_binary_mask.R @@ -0,0 +1,15 @@ +#' Create a binary mask +#' +#' Create a binary mask from a raster: NAs are converted to 0s, and +#' any other value to 1. +#' +#' @param x a [`terra::SpatRaster`] +#' @returns a [`terra::SpatRaster`] with 0s and 1s +#' +#' @keywords internal + +make_binary_mask <- function(x) { + x[!is.na(x)] <- 1 + x[is.na(x)] <- 0 + return(x) +} diff --git a/R/make_ice_mask.R b/R/make_ice_mask.R new file mode 100644 index 00000000..394128bd --- /dev/null +++ b/R/make_ice_mask.R @@ -0,0 +1,28 @@ +#' Downscale an ice mask +#' +#' Downscaling the ice mask presents some issues. The mask is a binary raster, +#' so any standard downscaling approach will still look very blocky. We can +#' smooth the contour by applying a Gaussian filter. How strong that filter +#' should be is very much a matter of personal opinion, as we do not have any +#' data to compare to. This function attempts to use as sensible default value, +#' but it is worth exploring alternative values to find a good solution. +#' +#' @param ice_mask_low_res a [`terra::SpatRaster`] of the low resolution ice mask +#' to downscale (e.g. as obtained with [get_ice_mask()]) +#' @param land_mask_high_res a [`terra::SpatRaster`] of the land masks at different +#' times (e.g. as obtained from [make_land_mask()]). The ice mask will be cropped +#' and matched for the resolution of this land mask. +#' @returns a [`terra::SpatRaster`] of the ice mask (1's), with the rest of the +#' world (sea and land) as NA's +#' +#' @keywords internal + +make_ice_mask <- function(ice_mask_low_res, land_mask_high_res, d = c(0.5, 3)) { + ice_mask_low_res_bin <- make_binary_mask(ice_mask_low_res) + ice_mask_high_res <- resample(ice_mask_low_res_bin, land_mask_high_res, method = "bilinear") + gauss_filt <- focalMat(ice_mask_high_res, d, "Gauss") + ice_mask_gf <- focal(ice_mask_high_res, w = gauss_filt) + ice_mask_gf[ice_mask_gf < 0.5] <- NA + ice_mask_gf[!is.na(ice_mask_gf)] <- 1 + return(ice_mask_gf) +} diff --git a/R/make_land_mask.R b/R/make_land_mask.R new file mode 100644 index 00000000..704ddb7f --- /dev/null +++ b/R/make_land_mask.R @@ -0,0 +1,62 @@ +#' Create a land mask +#' +#' Create a land mask for a given time step. The land mask is based on the simple +#' logic of moving the ocean up and down given the current relief profile ( +#' topography+bathymetry, i.e. the elevation both above and below sea level). +#' Note that this approach ignores any rebound due to changing mass and distribution of +#' ice sheets. +#' LIMITATIONS: The land mask will show internal lakes/seas as land, as their level +#' is unrelated to the general sea level. If you have specific reconstructions +#' of internal lakes (or want to simply reuse their current extents), you will +#' have to add them onto the masks generated by this function. Also note that the +#' land mask does not include ice sheets. This means that some areas that are permanently +#' covered by ice at the two poles will show up as sea. This means that, for any +#' reconstruction including Greenland or Antarctica, the resulting land mask will +#' need to be modified to include the appropriate ice sheets. +#' +#' @param relief_rast a [`terra::SpatRaster`] with relief +#' @param time_bp the time of interest +#' @param sea_level sea level at the time of interest (if left to NULL, this is +#' computed using Spratt 2016) +#' @returns a [`terra::SpatRaster`] of the land masks (with land as 1's and sea +#' as NAs), where the layers are different times +#' +#' @keywords internal + +make_land_mask <- function(relief_rast, time_bp, sea_level = NULL) { + message("This function is still under development; do not use it for real analysis") + if (is.null(sea_level)) { + sea_level <- get_sea_level(time_bp = time_bp) + } else { # check that we have as many sea level estimates as times + if (length(time_bp) != length(sea_level)) { + stop("time_bp and sea_level should have the same number of elements") + } + } + land_mask <- NULL + for (i in seq_along(time_bp)) { + # create binary relief map for areas above and below the relevant sea level + relief_bin <- relief_rast + relief_bin[relief_bin > sea_level[i]] <- NA + relief_bin[!is.na(relief_bin)] <- 1 + sea_patches <- patches(relief_bin, directions = 8) + # get mode of a vector (removing any NAs) + modal_vector <- function(x) { + x <- x[!is.na(x)] + ux <- unique(x) + ux[which.max(tabulate(match(x, ux)))] + } + patch_to_get <- modal_vector(values(sea_patches)) + sea_patches[is.na(sea_patches)] <- -1 + sea_patches[sea_patches != patch_to_get] <- -1 + sea_patches[sea_patches > 0] <- NA + sea_patches <- -sea_patches + names(sea_patches) <- "mask" + if (is.null(land_mask)) { + land_mask <- sea_patches + } else { + add(land_mask) <- sea_patches + } + } + terra::time(land_mask, tstep = "years") <- (time_bp + 1950) + return(land_mask) +} diff --git a/R/pastclim.R b/R/pastclim.R index f9f6f64c..a49c6817 100644 --- a/R/pastclim.R +++ b/R/pastclim.R @@ -2,11 +2,11 @@ #' #' This `R` library is designed to provide an easy way to extract and manipulate palaeoclimate #' reconstructions for ecological and anthropological analyses. -#' -#' The functionalities of `pastclim` are described in +#' +#' The functionalities of `pastclim` are described in #' Leonardi et al. (2023) \doi{10.1111/ecog.06481}. Please cite it if you #' use `pastclim` in your research. -#' +#' #' On its dedicated [website](https://evolecolgroup.github.io/pastclim/), you can find #' Articles giving you a step-by-step [overview of the package](https://evolecolgroup.github.io/pastclim/articles/a0_pastclim_overview.html), #' and a [cheatsheet](https://evolecolgroup.github.io/pastclim/pastclim_cheatsheet.pdf). @@ -15,9 +15,9 @@ #' updated for the `dev` version (on the top left, the version number is in #' red, and will be in the format x.x.x.9xxx, indicating it is a #' development version). -#' -#' `pastclim` currently includes data from Beyer et al 2020, a reconstruction of climate -#' based on the HadCM3 +#' +#' `pastclim` currently includes data from Beyer et al 2020, a reconstruction of climate +#' based on the HadCM3 #' model for the last 120k years, and Krapp et al 2021, which covers the last 800k years. #' The reconstructions are bias-corrected and downscaled to 0.5 degree. More details on these datasets #' can be found [here](https://evolecolgroup.github.io/pastclim/articles/a1_available_datasets.html). @@ -25,6 +25,7 @@ #' #' @docType package #' @name pastclim +#' @aliases pastclim-package #' @import methods #' @import terra NULL diff --git a/R/region_series.R b/R/region_series.R index 44a42654..93901638 100644 --- a/R/region_series.R +++ b/R/region_series.R @@ -12,18 +12,21 @@ #' to exist in the dataset), a list with a min and max element setting the #' range of values, or left to NULL to retrieve all time steps. #' To check which slices are available, you can use -#' [get_time_steps()]. +#' [get_time_bp_steps()]. +#' @param time_ce time slices in years CE (see `time_bp` for options). +#' For available time slices in years CE, use [get_time_ce_steps()]. +#' Only one of `time_bp` or `time_ce` should be used. #' @param bio_variables vector of names of variables to be extracted #' @param dataset string defining the dataset to use. If set to "custom", #' then a single nc file is used from "path_to_nc" #' @param path_to_nc the path to the custom nc file containing the palaeoclimate #' reconstructions. All the variables of interest need to be included in #' this file. -#' @param ext an extent, coded as numeric vector (length=4; +#' @param ext an extent, coded as numeric vector (length=4; #' order= xmin, xmax, ymin, ymax) or a [terra::SpatExtent] object. If NULL, #' the full extent of the reconstruction is given. #' @param crop a polygon used to crop the reconstructions (e.g. the outline -#' of a continental mass). A [`sf::sfg`][sf::st] or a [terra::SpatVector] object +#' of a continental mass). A [`sf::sfg`][sf::st] or a [terra::SpatVector] object #' is used to define the polygon. #' @returns a #' [`terra::SpatRasterDataset`] object, with @@ -34,33 +37,42 @@ region_series <- function(time_bp = NULL, + time_ce = NULL, bio_variables, dataset, path_to_nc = NULL, ext = NULL, crop = NULL) { - + time_bp <- check_time_vars(time_bp = time_bp, time_ce = time_ce) + check_dataset_path(dataset = dataset, path_to_nc = path_to_nc) + if (dataset == "Barreto2023") { + message("This is a large dataset, it might take a while...") + } - if (!is.null(ext)){ - if(!any(inherits(ext,"SpatExtent"), - all(inherits(ext,"numeric"), length(ext)==4))){ - stop ("ext should be a numeric vector of length 4 or a terra::SpatExtent object created terra::ext") + if (!is.null(ext)) { + if (!any( + inherits(ext, "SpatExtent"), + all(inherits(ext, "numeric"), length(ext) == 4) + )) { + stop("ext should be a numeric vector of length 4 or a terra::SpatExtent object created terra::ext") } - if (inherits(ext,"numeric")){ + if (inherits(ext, "numeric")) { ext <- terra::ext(ext) } } - if (!is.null(crop)){ - if(!any(inherits(crop,"SpatVector"), - inherits(crop,"sfg"))){ - stop ("crop should be a sf::sfg or a terra::SpatVector object created with terra::vect") + if (!is.null(crop)) { + if (!any( + inherits(crop, "SpatVector"), + inherits(crop, "sfg") + )) { + stop("crop should be a sf::sfg or a terra::SpatVector object created with terra::vect") } - if(inherits(crop,"sfg")){ + if (inherits(crop, "sfg")) { crop <- terra::vect(crop) } } - + # check whether the variables exist for this dataset if (dataset != "custom") { # if we are using standard datasets check_var_downloaded(bio_variables, dataset) @@ -85,28 +97,32 @@ region_series <- if (is.null(time_index)) { # as we have the file name, we can us the same code for custom and # standard datasets. - times <- get_time_steps(dataset = "custom", path_to_nc = this_file) - time_index <- time_bp_to_i_series(time_bp = time_bp, - time_steps = times) + times <- get_time_bp_steps(dataset = "custom", path_to_nc = this_file) + time_index <- time_bp_to_i_series( + time_bp = time_bp, + time_steps = times + ) } var_brick <- terra::rast(this_file, subds = this_var_nc) + + # subset to time steps + if (!is.null(time_bp)) { + var_brick <- terra::subset(var_brick, subset = time_index) + } + # subset extent - if (!is.null(ext)){ + if (!is.null(ext)) { var_brick <- terra::crop(var_brick, ext) } # subset to crop - if (!is.null(crop)){ + if (!is.null(crop)) { terra::crs(crop) <- terra::crs(var_brick) var_brick <- terra::mask(var_brick, crop) var_brick <- terra::crop(var_brick, crop) } - - if (!is.null(time_bp)){ - climate_spatrasters[[this_var]] <- terra::subset(var_brick, - subset = time_index) - } else { - climate_spatrasters[[this_var]] <- var_brick - } + + climate_spatrasters[[this_var]] <- var_brick + varnames(climate_spatrasters[[this_var]]) <- this_var names(climate_spatrasters[[this_var]]) <- paste(this_var, time_bp(climate_spatrasters[[this_var]]), diff --git a/R/region_slice.R b/R/region_slice.R index b2c82454..c0130ab5 100644 --- a/R/region_slice.R +++ b/R/region_slice.R @@ -9,43 +9,47 @@ #' values represent #' time before present, positive values time in the future). The slice needs #' to exist in the dataset. To check which slices are available, you can use -#' [get_time_steps()]. +#' [get_time_bp_steps()]. +#' @param time_ce time slice in years CE. +#' For available time slices in years CE, use [get_time_ce_steps()]. +#' Only one of `time_bp` or `time_ce` should be used. #' @param bio_variables vector of names of variables to be extracted #' @param dataset string defining the dataset to use. If set to "custom", #' then a single nc file is used from "path_to_nc" #' @param path_to_nc the path to the custom nc file containing the palaeoclimate #' reconstructions. All the variables of interest need to be included #' in this file. -#' @param ext an extent, coded as numeric vector (length=4; +#' @param ext an extent, coded as numeric vector (length=4; #' order= xmin, xmax, ymin, ymax) or a [terra::SpatExtent] object. If NULL, #' the full extent of the reconstruction is given. #' @param crop a polygon used to crop the reconstructions (e.g. the outline -#' of a continental mass). A [`sf::sfg`][sf::st] or a [terra::SpatVector] object +#' of a continental mass). A [`sf::sfg`][sf::st] or a [terra::SpatVector] object #' is used to define the polygon. #' @returns a #' SpatRaster [`terra::SpatRaster`] object, with #' each variable as a layer. -#' +#' #' @import terra #' @export region_slice <- - function(time_bp, + function(time_bp = NULL, + time_ce = NULL, bio_variables, dataset, path_to_nc = NULL, ext = NULL, crop = NULL) { - this_series <- region_series( time_bp = time_bp, + time_ce = time_ce, bio_variables = bio_variables, dataset = dataset, path_to_nc = path_to_nc, ext = ext, crop = crop ) - return(slice_region_series(x = this_series, time_bp = time_bp)) + return(slice_region_series(x = this_series, time_bp = time_bp, time_ce = time_ce)) } diff --git a/R/sample_region_series.R b/R/sample_region_series.R index 3a621542..8b8ec625 100644 --- a/R/sample_region_series.R +++ b/R/sample_region_series.R @@ -2,11 +2,11 @@ #' #' This function samples points from a region time series. Sampling can either be #' performed for the same locations at all time steps (if only one value is given -#' for `size`), or for different locations for each time step (if `size` is a +#' for `size`), or for different locations for each time step (if `size` is a #' vector of length equal to the number of time steps). To sample the same #' number of points, but different locations, for each time step, provide a vector #' repeating the same value for each time step. -#' +#' #' This function wraps [terra::spatSample()] to appropriate sample the #' [`terra::SpatRaster`]s in the [`terra::SpatRasterDataset`] returned #' by [region_series()]. @@ -25,23 +25,21 @@ #' #' @export -sample_region_series<-function(x, size, method="random", replace=FALSE, na.rm=TRUE) -{ - if (!is_region_series(x)){ +sample_region_series <- function(x, size, method = "random", replace = FALSE, na.rm = TRUE) { + if (!is_region_series(x)) { stop("x is not a valid object generated by region_series") } - - if (length(size)==1) - { - sample_rs_fixed(x,size,method=method, replace=replace, na.rm=na.rm) + + if (length(size) == 1) { + sample_rs_fixed(x, size, method = method, replace = replace, na.rm = na.rm) } else { - sample_rs_variable(x,size,method=method, replace=replace, na.rm=na.rm) + sample_rs_variable(x, size, method = method, replace = replace, na.rm = na.rm) } -} - +} + #' Sample the same locations from a region time series #' -#' Internal function for fixed sampling from [sample_region_series()], +#' Internal function for fixed sampling from [sample_region_series()], #' used when a single size is given. #' #' @param x a [`terra::SpatRasterDataset`] returned @@ -57,37 +55,39 @@ sample_region_series<-function(x, size, method="random", replace=FALSE, na.rm=TR #' #' @keywords internal -sample_rs_fixed<-function(x, size, method="random", replace=FALSE, na.rm=TRUE) - { +sample_rs_fixed <- function(x, size, method = "random", replace = FALSE, na.rm = TRUE) { # sample the first variable # spatSample samples additional points to make sure it has enough points after # removing NA. The default exp=5 is not sufficient if size is very small. - if ((size*5)<1000){ - exp = ceiling(1000/size) + if ((size * 5) < 1000) { + exp <- ceiling(1000 / size) } else { - exp = 5 + exp <- 5 } - var_values <- terra::spatSample(x[1], size, method=method, - replace=replace, na.rm=na.rm, - cells=TRUE, xy=TRUE, exp=exp) + var_values <- terra::spatSample(x[1], size, + method = method, + replace = replace, na.rm = na.rm, + cells = TRUE, xy = TRUE, exp = exp + ) # get the details for the sampled cells - sampled_cells <- var_values[,c("cell","x","y")] + sampled_cells <- var_values[, c("cell", "x", "y")] sampled_values <- sampled_cells[rep(seq_len(nrow(sampled_cells)), - times=length(time_bp(x[1]))),] - sampled_values$time_bp <- rep(time_bp(x[1]), each=nrow(sampled_cells)) + times = length(time_bp(x[1])) + ), ] + sampled_values$time_bp <- rep(time_bp(x[1]), each = nrow(sampled_cells)) # let's reuse these vales - - for (this_var in names(x)){ - if (this_var != names(x)[1]){ + + for (this_var in names(x)) { + if (this_var != names(x)[1]) { # extract values for this variable - var_values <- terra::extract(x[this_var],sampled_cells$cell) + var_values <- terra::extract(x[this_var], sampled_cells$cell) } else { # reuse the values obtained from spatSample - var_values <- var_values[,-c(1:3)] + var_values <- var_values[, -c(1:3)] } - colnames(var_values)<-time_bp(x[1]) - var_values<-utils::stack(var_values) - sampled_values[this_var]<- var_values[,1] + colnames(var_values) <- time_bp(x[1]) + var_values <- utils::stack(var_values) + sampled_values[this_var] <- var_values[, 1] } return(sampled_values) } @@ -95,7 +95,7 @@ sample_rs_fixed<-function(x, size, method="random", replace=FALSE, na.rm=TRUE) #' Sample the different number of points from a region time series #' #' Internal function for sampling different number of points for each -#' timestep of a region series from [sample_region_series()], +#' timestep of a region series from [sample_region_series()], #' used when size is a vector of values. #' #' @param x a [`terra::SpatRasterDataset`] returned @@ -110,37 +110,37 @@ sample_rs_fixed<-function(x, size, method="random", replace=FALSE, na.rm=TRUE) #' #' @keywords internal -sample_rs_variable<-function(x, size, method="random", replace=FALSE, na.rm=TRUE) -{ - if (sum(size)==0){ +sample_rs_variable <- function(x, size, method = "random", replace = FALSE, na.rm = TRUE) { + if (sum(size) == 0) { stop("at least one element of sample size should be larger than zero") } - if (length(size)!=length(time_bp(x[1]))){ + if (length(size) != length(time_bp(x[1]))) { stop("size should be the same length as the number of time steps in x") } # create list to store samples for each time step - sample_list<-list() + sample_list <- list() t_steps <- time_bp(x[1]) - for (i in seq_len(length(size))){ - if (size[i]>0) { - x_step <- slice_region_series(x,t_steps[i]) + for (i in seq_len(length(size))) { + if (size[i] > 0) { + x_step <- slice_region_series(x, t_steps[i]) # spatSample samples additional points to make sure it has enough points after # removing NA. The default exp=5 is not sufficient if size is very small. - if ((size[i]*5)<1000){ - exp = ceiling(1000/size[i]) + if ((size[i] * 5) < 1000) { + exp <- ceiling(1000 / size[i]) } else { - exp = 5 # the terra default + exp <- 5 # the terra default } - values <- terra::spatSample(x_step, size[i], method=method, - replace=replace, na.rm=na.rm, - cells=TRUE, xy=TRUE, exp=exp) - values$time_bp<- t_steps[i] + values <- terra::spatSample(x_step, size[i], + method = method, + replace = replace, na.rm = na.rm, + cells = TRUE, xy = TRUE, exp = exp + ) + values$time_bp <- t_steps[i] # write into output - sample_list[[as.character(t_steps[i])]]<-values + sample_list[[as.character(t_steps[i])]] <- values } } # combine them into a single matrix sampled_climate <- do.call(rbind, sample_list) return(sampled_climate) -} - +} diff --git a/R/sample_region_slice.R b/R/sample_region_slice.R index 9da06e97..800a5e2b 100644 --- a/R/sample_region_slice.R +++ b/R/sample_region_slice.R @@ -1,7 +1,7 @@ #' Sample points from a region time slice #' #' This function samples points from a region time slice (i.e. a time point). -#' +#' #' This function wraps [terra::spatSample()] to appropriate sample the #' [`terra::SpatRaster`] returned #' by [region_slice()]. You can also use [terra::spatSample()] directly @@ -19,19 +19,19 @@ #' @export -sample_region_slice<-function(x, size, method="random", replace=FALSE, na.rm=TRUE) -{ - if (length(size)!=1) - { +sample_region_slice <- function(x, size, method = "random", replace = FALSE, na.rm = TRUE) { + if (length(size) != 1) { stop("size should be a single value") } # spatSample samples additional points to make sure it has enough points after # removing NA. The default exp=5 is not sufficient if size is very small. - if ((size*5)<1000){ - exp = ceiling(1000/size) + if ((size * 5) < 1000) { + exp <- ceiling(1000 / size) } else { - exp = 5 + exp <- 5 } - terra::spatSample(x, size, method=method, replace=replace, na.rm=na.rm, - cells = TRUE, xy = TRUE, exp = exp) -} + terra::spatSample(x, size, + method = method, replace = replace, na.rm = na.rm, + cells = TRUE, xy = TRUE, exp = exp + ) +} diff --git a/R/set_data_path.R b/R/set_data_path.R index ab7a9ba5..45b78910 100644 --- a/R/set_data_path.R +++ b/R/set_data_path.R @@ -15,59 +15,83 @@ #' file #' @param copy_example boolean on whether the example dataset should be saved #' in the data_path +#' @param on_CRAN boolean; users should NOT need this parameters. It is used to set up a +#' data path in the temporary directory for examples and tests +#' to run on CRAN. #' @return TRUE if the path was set correctly #' #' @export set_data_path <- function(path_to_nc = NULL, ask = TRUE, write_config = TRUE, - copy_example = TRUE) { + copy_example = TRUE, on_CRAN = FALSE) { + # set up options that we will need for running on CRAN + if (on_CRAN) { + # set up data path for this test + path_to_nc <- file.path(tempdir(), "pastclim_data") + # clear it if it exists + unlink(path_to_nc, recursive = TRUE) + # set data path + ask <- FALSE + write_config <- FALSE + copy_example <- TRUE + } + if (is.null(path_to_nc)) { data_dir <- tools::R_user_dir("pastclim", "data") } else { - data_dir <- path_to_nc + data_dir <- normalizePath(path_to_nc, mustWork = FALSE) } - if (ask){ # if we ask the user - message_to_user<-paste0("The data_path will be set to ", - data_dir,".\n") - if (copy_example){ - message_to_user<-paste0(message_to_user, - "A copy of the Example dataset will be copied there.\n") + if (ask) { # if we ask the user + message_to_user <- paste0( + "The data_path will be set to ", + data_dir, ".\n" + ) + if (copy_example) { + message_to_user <- paste0( + message_to_user, + "A copy of the Example dataset will be copied there.\n" + ) } - - if (write_config){ - message_to_user<-paste0(message_to_user, - "This path will be saved by pastclim for future use.\n") + + if (write_config) { + message_to_user <- paste0( + message_to_user, + "This path will be saved by pastclim for future use.\n" + ) } else { - message_to_user<-paste0(message_to_user, - "You have chosen not to save the path for future use.\n", - "You will have to reset the path when R is restarted.\n") + message_to_user <- paste0( + message_to_user, + "You have chosen not to save the path for future use.\n", + "You will have to reset the path when R is restarted.\n" + ) } - message_to_user<-paste0(message_to_user,"Proceed?") - user_choice <- utils::menu(c("Yes","No"), title = message_to_user) + message_to_user <- paste0(message_to_user, "Proceed?") + user_choice <- utils::menu(c("Yes", "No"), title = message_to_user) } else { # else, if we don't ask, answer yes - user_choice <- 1 + user_choice <- 1 } - + # if the user said yes - if (user_choice==1){ + if (user_choice == 1) { # if the data directory does not exist, attempt to make it if (!dir.exists(data_dir)) { dir.create(data_dir, recursive = TRUE) # do we need to check successful dir creation, or does it raise an error? } # if requested, write the path in a config file for future use - if (write_config){ + if (write_config) { # if we don't have a config directory, create one if (!dir.exists(tools::R_user_dir("pastclim", "config"))) { dir.create(tools::R_user_dir("pastclim", "config"), recursive = TRUE) } utils::write.table(data_dir, - row.names = FALSE, - col.names = FALSE, - file = file.path( - tools::R_user_dir("pastclim", "config"), - "pastclim_data.txt" - )) + row.names = FALSE, + col.names = FALSE, + file = file.path( + tools::R_user_dir("pastclim", "config"), + "pastclim_data.txt" + ) + ) } } else { # if the user said no message("Aborted: the data path was not set.") @@ -76,17 +100,17 @@ set_data_path <- function(path_to_nc = NULL, ask = TRUE, write_config = TRUE, # update option options(pastclim.data_path = data_dir) # if requested, copy the example dataset in it - if (copy_example){ + if (copy_example) { copy_example_data() } - return (TRUE) + return(TRUE) } #' Internal function to copy the example dataset when a new data path is set #' #' Copy example dataset -#' +#' #' @returns TRUE if the data were copied successfully #' #' @keywords internal @@ -95,33 +119,11 @@ copy_example_data <- function() { example_filename <- unique(getOption("pastclim.dataset_list")$file_name[getOption("pastclim.dataset_list")$dataset == "Example"]) if (!file.exists(file.path(get_data_path(), example_filename))) { file.copy( - from = system.file(file.path("/extdata",example_filename), - package = "pastclim" + from = system.file(file.path("/extdata", example_filename), + package = "pastclim" ), to = file.path(get_data_path(), example_filename) ) } return(TRUE) } - -#' Set the data path for examples on CRAN -#' -#' Users should NOT need this function. It is used to set up a -#' data path in the temporary directory for examples and tests -#' to run on CRAN. -#' -#' @returns None -#' @export - - -set_data_path_for_CRAN <- function() { - # set up data path for this test - data_path <- file.path(tempdir(),"pastclim_data") - # clear it if it exists - unlink(data_path, recursive = TRUE) - # set data path - set_data_path(path_to_nc = data_path, - ask = FALSE, - write_config = FALSE, - copy_example = TRUE) -} diff --git a/R/slice_region_series.R b/R/slice_region_series.R index ae0cf23c..cefab228 100644 --- a/R/slice_region_series.R +++ b/R/slice_region_series.R @@ -4,21 +4,23 @@ #' variables for a given dataset covering a region (or the whole world). #' #' @param x climate time series generated with [region_series()] -#' @param time_bp time slices in years before present (i.e. 1950, negative integers +#' @param time_bp time slice +#' in years before present (i.e. 1950, negative integers #' for values in the past). The slices #' need to exist in the dataset. To check which slices are available, you -#' can use `time_bp(x[[1]])` (note that you have to use -#' the [time_bp()] function on the first element of the [`terra::SpatRasterDataset`] object, i.e. on one -#' of the [`terra::SpatRaster`] objects) +#' can use `time_bp(x)`. +#' @param time_ce time slice in years CE. Only one of `time_bp` or `time_ce` should +#' be used. #' @returns a [SpatRaster] of the relevant slice. #' #' @export -slice_region_series <- function(x, time_bp) { +slice_region_series <- function(x, time_bp = NULL, time_ce = NULL) { + time_bp <- check_time_vars(time_bp = time_bp, time_ce = time_ce, allow_null = FALSE) if (length(time_bp) != 1) { stop("time_bp should be a single time step") } - if (!is_region_series(x)){ + if (!is_region_series(x)) { stop("x is not a valid object generated by region_series") } # check that time_bp is part of the series diff --git a/R/sysdata.rda b/R/sysdata.rda index 8a83e4ae..10dd0eda 100644 Binary files a/R/sysdata.rda and b/R/sysdata.rda differ diff --git a/R/time_bp.R b/R/time_bp.R index 85020e9e..a1f7462d 100644 --- a/R/time_bp.R +++ b/R/time_bp.R @@ -1,9 +1,9 @@ -#' Extract and set time in years before present for SpatRaster +#' Extract and set time in years before present for SpatRaster and SpatRasterDataset #' #' This functions extracts and sets time in years BP (i.e. from 1950) for a -#' [`terra::SpatRaster`]. In the [`terra::SpatRaster`] object, time is +#' [`terra::SpatRaster`] or a [`terra::SpatRasterDataset`]. In a [`terra::SpatRaster`] object, time is #' stored with unit "years", which -#' are years from 0AD. This means that, when a summary of the +#' are years from 0AD. This means that, when a summary of the #' [`terra::SpatRaster`] is #' inspected, the times will appear as `time_bp`+1950. The same applies when the #' function [terra::time()] is used instead of [time_bp()]. @@ -15,37 +15,83 @@ #' @import methods #' @export -setGeneric("time_bp", function(x) - standardGeneric("time_bp") ) +setGeneric("time_bp", function(x) { + standardGeneric("time_bp") +}) #' @rdname time_bp #' @export -#time_bp <- function(x){ -setMethod("time_bp", signature(x="SpatRaster"), - function(x) { - if (timeInfo(x)$step != "years") { - # as of 1.7.18, the bug in terra setting years to negative has ben fixed - stop("The time units of SpatRaster are not 'years'.\n", - "It might be a problem with the time units not being properly set in the original nc file.\n", - "Set time units correctly with time_bp(x)<-c(-10000,-400).\n", - "NOTE do NOT use terra:time, as that terra measures years from 0AD, not BP") +setMethod( + "time_bp", signature(x = "SpatRaster"), + function(x) { + if (timeInfo(x)$step != "years") { + # as of 1.7.18, the bug in terra setting years to negative has ben fixed + stop( + "The time units of SpatRaster are not 'years'.\n", + "It might be a problem with the time units not being properly set in the original nc file.\n", + "Set time units correctly with time_bp(x)<-c(-10000,-400).\n", + "NOTE do NOT use terra:time, as that terra measures years from 0AD, not BP" + ) + } + time_yr <- terra::time(x) + return(time_yr - 1950) } - time_yr<-terra::time(x) - return(time_yr-1950) -}) +) + +#' @rdname time_bp +#' @export +setMethod( + "time_bp", signature(x = "SpatRasterDataset"), + function(x) { + if (!is_region_series(x)) { + stop("this is not a valid region series; it should be a SpatRasterDataset where each dataset (i.e. variable) has the same time steps") + } + if (timeInfo(x[[1]])$step != "years") { + # as of 1.7.18, the bug in terra setting years to negative has been fixed + stop( + "The time units of SpatRaster are not 'years'.\n", + "It might be a problem with the time units not being properly set in the original nc file.\n", + "Set time units correctly with time_bp(x)<-c(-10000,-400).\n", + "NOTE do NOT use terra:time, as that terra measures years from 0AD, not BP" + ) + } + time_yr <- terra::time(x[[1]]) + return(time_yr - 1950) + } +) + + #' @rdname time_bp #' @export -setGeneric("time_bp<-", function(x, value) - standardGeneric("time_bp<-") ) +setGeneric("time_bp<-", function(x, value) { + standardGeneric("time_bp<-") +}) #' @rdname time_bp #' @export -setMethod("time_bp<-", signature(x="SpatRaster"), - function(x, value) { - value_bp <- value+1950 - time(x,tstep="years")<-value_bp - return(x) - } +setMethod( + "time_bp<-", signature(x = "SpatRaster"), + function(x, value) { + value_bp <- value + 1950 + time(x, tstep = "years") <- value_bp + return(x) + } ) +#' @rdname time_bp +#' @export +setMethod( + "time_bp<-", signature(x = "SpatRasterDataset"), + function(x, value) { + if (!is_region_series(x)) { + stop("this is not a valid region series; it should be a SpatRasterDataset where each dataset (i.e. variable) has the same time steps") + } + # convert yrs BP to yrs AD for terra + value_bp <- value + 1950 + for (i in 1:length(x)) { + time(x[i], tstep = "years") <- value_bp + } + return(x) + } +) diff --git a/R/time_bp_to_i_series.R b/R/time_bp_to_i_series.R index 11ba5110..aa749e5b 100644 --- a/R/time_bp_to_i_series.R +++ b/R/time_bp_to_i_series.R @@ -5,31 +5,31 @@ #' @param time_bp vector of times BP #' @param time_steps time steps for which reconstructions are available #' @returns the indeces for the relevant time steps -#' +#' #' @keywords internal -time_bp_to_i_series<-function(time_bp, time_steps){ +time_bp_to_i_series <- function(time_bp, time_steps) { # if this is a vector, just use the values - if (is.numeric(time_bp)){ + if (is.numeric(time_bp)) { time_index <- match(time_bp, time_steps) if (any(is.na(time_index))) { stop("time_bp should only include time steps available in the dataset") } - # if this is a list - } else if (inherits(time_bp,"list")){ - if (!all(names(time_bp)==c("min","max"))){ + # if this is a list + } else if (inherits(time_bp, "list")) { + if (!all(names(time_bp) == c("min", "max"))) { stop("time_bp should be a list with min and max elements") } - if (time_bp$min>time_bp$max){ + if (time_bp$min > time_bp$max) { stop("in time_bp, min should be less than max") } - time_bp <- time_steps[time_steps>=time_bp$min & time_steps<=time_bp$max] + time_bp <- time_steps[time_steps >= time_bp$min & time_steps <= time_bp$max] time_index <- match(time_bp, time_steps) # finally give an error if this is not null - } else if (is.null(time_bp)){ + } else if (is.null(time_bp)) { time_index <- NULL } else { - stop ("time_bp can only be NULL, a numeric vector, or a list with min and max values") + stop("time_bp can only be NULL, a numeric vector, or a list with min and max values") } return(time_index) } diff --git a/R/update_dataset_list.R b/R/update_dataset_list.R index b5010d5b..f7c4102a 100644 --- a/R/update_dataset_list.R +++ b/R/update_dataset_list.R @@ -2,7 +2,7 @@ #' #' If a newer dataset list (which includes all the information about the files #' storing the data for pastclim), download it and start using it as -#' 'dataset_list_included.csv' in +#' 'dataset_list_included.csv' in #' `tools::R_user_dir("pastclim","config")`. If the latter is present, the last #' column, named 'dataset_list_v', provides the version of this table, and the #' most advanced table is used. @@ -11,16 +11,26 @@ #' @returns TRUE if the dataset was updated #' @export -update_dataset_list <- function(on_cran=FALSE) { +update_dataset_list <- function(on_cran = FALSE) { curl::curl_download("https://raw.githubusercontent.com/EvolEcolGroup/pastclim/dataset_list/dataset_list_included.csv", - destfile = file.path(tempdir(), "dataset_list_included.csv"), - quiet = FALSE) + destfile = file.path(tempdir(), "dataset_list_included.csv"), + quiet = FALSE + ) new_table_github <- utils::read.csv(file.path(tempdir(), "dataset_list_included.csv")) # if the github version is more recent, copy it into config - if (utils::compareVersion(new_table_github$dataset_list_v[1], - getOption("pastclim.dataset_list")$dataset_list_v[1])==1){ + if (utils::compareVersion( + new_table_github$dataset_list_v[1], + getOption("pastclim.dataset_list")$dataset_list_v[1] + ) == 1) { + # set the config directory (we use the tempdir if we are on CRAN) + if (!on_cran) { + config_dir <- tools::R_user_dir("pastclim", "config") + } else { + config_dir <- tempdir() + } file.copy(utils::read.csv(file.path(tempdir(), "dataset_list_included.csv")), - to= file.path(tools::R_user_dir("pastclim", "config"),"dataset_list_included.csv")) + to = file.path(config_dir, "dataset_list_included.csv") + ) load_dataset_list() message("The dataset list was updated.") return(TRUE) @@ -28,5 +38,4 @@ update_dataset_list <- function(on_cran=FALSE) { message("The dataset list currently installed is already the latest version.") return(FALSE) } - } diff --git a/R/validate_nc.R b/R/validate_nc.R index 7e7f845f..d79cfd31 100644 --- a/R/validate_nc.R +++ b/R/validate_nc.R @@ -1,6 +1,6 @@ #' Validate an netcdf file for pastclim -#' -#' This function validates a netcdf file as a potential dataset for `pastlim`. +#' +#' This function validates a netcdf file as a potential dataset for `pastclim`. #' The key checks are: #' a) that the dimensions (longitude, latitude and time) have been set correctly. #' b) that all variables have the appropriate metadata (longname and units) @@ -12,43 +12,49 @@ validate_nc <- function(path_to_nc) { # check that file exists - if (!file.exists(path_to_nc)){ + if (!file.exists(path_to_nc)) { stop("The provided path_to_nc is not valid.") } # check dimension names - nc_in<-ncdf4::nc_open(path_to_nc) - if (!any(all(c("longitude","latitude","time") %in% names(nc_in$dim)), - all(c("lon","lat","time") %in% names(nc_in$dim))) - ){ + nc_in <- ncdf4::nc_open(path_to_nc) + if (!any( + all(c("longitude", "latitude", "time") %in% names(nc_in$dim)), + all(c("lon", "lat", "time") %in% names(nc_in$dim)) + ) + ) { ncdf4::nc_close(nc_in) stop("the dimension names should be: longitude, latitude and time") } # check that time has the correct units of 'years since XXXX' - if (identical(grep(pattern="^years since",nc_in$dim$time$units),integer(0))){ + if (identical(grep(pattern = "^years since", nc_in$dim$time$units), integer(0))) { ncdf4::nc_close(nc_in) - stop ("the time units should start with 'years since', but this file has\n", - "'", nc_in$dim$time$units, "'") + stop( + "the time units should start with 'years since', but this file has\n", + "'", nc_in$dim$time$units, "'" + ) } - if (nc_in$dim$time$units=="years since present"){ - ncdf4::nc_close(nc_in) - stop("the time units are 'years since present'.\n", - "terra interprets 'present' as 1970, which differs from the more\n", - "usual 1950 used for radiocarbon dates. To avoid errors, define\n", - "explicitely the reference date, e.g. 'years since 1950'") + if (nc_in$dim$time$units == "years since present") { + ncdf4::nc_close(nc_in) + stop( + "the time units are 'years since present'.\n", + "terra interprets 'present' as 1970, which differs from the more\n", + "usual 1950 used for radiocarbon dates. To avoid errors, define\n", + "explicitely the reference date, e.g. 'years since 1950'" + ) } - + # check that each variable has a longname (units could be # empty for categorical variables or variables that are unitless) - for (i in names(nc_in$var)){ - if (nchar(nc_in$var[[i]]$longname)==0){ + for (i in names(nc_in$var)) { + if (nchar(nc_in$var[[i]]$longname) == 0) { ncdf4::nc_close(nc_in) - stop("for ",i," the longname is not given") + stop("for ", i, " the longname is not given") } } - + # at some point, check that we have units that can be converted to pretty labels - + ncdf4::nc_close(nc_in) return(TRUE) } diff --git a/R/var_labels.R b/R/var_labels.R index 283f9d16..26dcd7d5 100644 --- a/R/var_labels.R +++ b/R/var_labels.R @@ -3,10 +3,10 @@ #' Generate pretty labels (in the form of an [expression]) that can be used #' for plotting #' -#' @param x either a character vector with the names of the variables, or a +#' @param x either a character vector with the names of the variables, or a #' [`terra::SpatRaster`] generated with [region_slice())] #' @param dataset string defining dataset to be downloaded (a list of possible -#' values can be obtained with [get_available_datasets()]). This function +#' values can be obtained with [list_available_datasets()]). This function #' will not work on custom datasets. #' @param with_units boolean defining whether the label should include units #' @param abbreviated boolean defining whether the label should use abbreviations @@ -16,57 +16,59 @@ #' @export #' @examples #' var_labels("bio01", dataset = "Example") -#' +#' #' # set the data_path for this example to run on CRAN #' # users don't need to run this line -#' set_data_path_for_CRAN() -#' +#' set_data_path(on_CRAN = TRUE) +#' #' # for a SpatRaster #' climate_20k <- region_slice( -#' time_bp = -20000, -#' bio_variables = c("bio01", "bio10", "bio12"), -#' dataset = "Example" +#' time_bp = -20000, +#' bio_variables = c("bio01", "bio10", "bio12"), +#' dataset = "Example" #' ) #' terra::plot(climate_20k, main = var_labels(climate_20k, dataset = "Example")) -#' terra::plot(climate_20k, main = var_labels(climate_20k, dataset = "Example", -#' abbreviated = TRUE)) - - -var_labels <- function(x, dataset, with_units=TRUE, - abbreviated = FALSE){ - if (is.null(dataset) | !(dataset %in% get_available_datasets())){ - stop("dataset should be one of ", - paste(get_available_datasets(), collapse=", ")) +#' terra::plot(climate_20k, main = var_labels(climate_20k, +#' dataset = "Example", +#' abbreviated = TRUE +#' )) +var_labels <- function(x, dataset, with_units = TRUE, + abbreviated = FALSE) { + if (is.null(dataset) | !(dataset %in% list_available_datasets())) { + stop( + "dataset should be one of ", + paste(list_available_datasets(), collapse = ", ") + ) } - if (inherits(x,"SpatRaster")){ + if (inherits(x, "SpatRaster")) { variables <- names(x) - } else if (inherits(x,"character")) { + } else if (inherits(x, "character")) { variables <- x } else { - stop ("x should be either a character vector or a SpatRaster") + stop("x should be either a character vector or a SpatRaster") } - + # get variable details for this dataset - sub_table <- getOption("pastclim.dataset_list")[getOption("pastclim.dataset_list")$dataset==dataset,] + sub_table <- getOption("pastclim.dataset_list")[getOption("pastclim.dataset_list")$dataset == dataset, ] indeces <- match(variables, sub_table$variable) - if (any(is.na(indeces))){ - stop (variables[which(is.na(indeces))]," does not exist in dataset ",dataset) + if (any(is.na(indeces))) { + stop(variables[which(is.na(indeces))], " does not exist in dataset ", dataset) } - - pretty_names <-c() - for (i in indeces){ - if (!abbreviated){ + + pretty_names <- c() + for (i in indeces) { + if (!abbreviated) { base_name <- sub_table$long_name[i] } else { base_name <- sub_table$abbreviated_name[i] } - if (sub_table$units[i]!="" & with_units){ - this_name <- paste('"',base_name,' ("',sub_table$units_exp[i],'")"', sep="") + if (sub_table$units[i] != "" & with_units) { + this_name <- paste('"', base_name, ' ("', sub_table$units_exp[i], '")"', sep = "") } else { - this_name <- paste('"',base_name,'"', sep="") + this_name <- paste('"', base_name, '"', sep = "") } - pretty_names <- c(pretty_names,this_name) + pretty_names <- c(pretty_names, this_name) } return(parse(text = pretty_names)) } diff --git a/R/ybp2date.R b/R/ybp2date.R new file mode 100644 index 00000000..bf522c49 --- /dev/null +++ b/R/ybp2date.R @@ -0,0 +1,32 @@ +#' Convert years BP from pastclim to lubridate date, or vice versa +#' +#' These functions convert between years BP as used by pastclim (negative +#' numbers going into +#' the past, positive into the future) and standard +#' `POSIXct` date objects. +#' @param x a time in years BP using the `pastclim` convention of +#' negative numbers indicating years into the past, or a `POSIXct` date object +#' @returns a `POSIXct` date object, or a vector +#' @examples +#' ybp2date(-10000) +#' ybp2date(0) +#' # back and forth +#' date2ybp(ybp2date(-10000)) +#' +#' @export + +ybp2date <- function(x) { + if (!is.numeric(x)) { + stop("x should be numeric") + } + lubridate::date_decimal(x + 1950) +} + +#' @rdname ybp2date +#' @export +date2ybp <- function(x) { + if (!inherits(x, "POSIXct")) { + stop("x should be a POSIXct object") + } + lubridate::year(x) - 1950 +} diff --git a/R/zzz.R b/R/zzz.R index ee3bd9c3..c86630d7 100644 --- a/R/zzz.R +++ b/R/zzz.R @@ -2,19 +2,21 @@ # store the data path as an option for easy retrieval op <- options() op.pastclim <- list( - pastclim.data_path = get_data_path(silent=TRUE), + pastclim.data_path = get_data_path(silent = TRUE), pastclim.dataset_list = load_dataset_list() ) toset <- !(names(op.pastclim) %in% names(op)) if (any(toset)) options(op.pastclim[toset]) # check that gdal was compiled with netcdf support - if (!"netCDF" %in% terra::gdal(drivers=TRUE)$name){ - stop("The installed version of terra lacks support for reading netcdf files.\n", - "pastclim needs netcdf support: you will need to reinstall terra,\n", - "possibly from source, if there isn't a version with netcdf support\n", - "on CRAN. Alternatively, try the latest development version from R-universe:\n", - "install.packages('terra', repos='https://rspatial.r-universe.dev')") + if (!"netCDF" %in% terra::gdal(drivers = TRUE)$name) { + stop( + "The installed version of terra lacks support for reading netcdf files.\n", + "pastclim needs netcdf support: you will need to reinstall terra,\n", + "possibly from source, if there isn't a version with netcdf support\n", + "on CRAN. Alternatively, try the latest development version from R-universe:\n", + "install.packages('terra', repos='https://rspatial.r-universe.dev')" + ) } invisible() diff --git a/README.md b/README.md index d0e7f867..9708f262 100644 --- a/README.md +++ b/README.md @@ -12,7 +12,8 @@ dev](https://img.shields.io/github/checks-status/EvolEcolGroup/pastclim/dev?labe This `R` library is designed to provide an easy way to extract and manipulate palaeoclimate reconstructions for ecological and -anthropological analyses. +anthropological analyses. It is also able to handle time series of future +reconstructions. The functionalities of `pastclim` are described in [Leonardi et al. (2023)](https://doi.org/10.1111/ecog.06481). Please cite it if you use @@ -54,10 +55,12 @@ updated for the `dev` branch of `pastclim` (on the top left of the dev website, the version number is in red and in the format x.x.x.9xxx, indicating it is a development version). -Pastclim currently includes data from Beyer et al 2020, a reconstruction -of climate based on the HadCM3 model for the last 120k years, and Krapp -et al 2021, which covers the last 800k years. The reconstructions are -bias-corrected and downscaled to 0.5 degree. More details on these +Pastclim currently includes data from Beyer et al 2020 (a reconstruction +of climate based on the HadCM3 model for the last 120k years), Krapp +et al 2021 (which covers the last 800k years with a statistical emulator of HadCM3), +Barreto et al 2023 (covering the last 5M years using the PALEO-PGEM emulator), +and the WorldClim data (present, and future projections with a number of models and +emission scenarios). More details on each of these datasets can be found [here](https://evolecolgroup.github.io/pastclim/articles/a1_available_datasets.html). There are also instructions on how to build and use [custom @@ -80,7 +83,7 @@ vignette("pastclim_overview", package = "pastclim") ------------------------------------------------------------------------ -## Current issues +## When something does not work If something does not work, check the [issues on GitHub](https://github.com/EvolEcolGroup/pastclim/issues) to see whether @@ -88,21 +91,5 @@ the problem has already been reported. If not, feel free to create an new issue. Please make sure you have updated to the latest version of `pastclim` on CRAN, as well as updating all other packages on your system, and provide [a reproducible -example](https://stackoverflow.com/questions/5963269/how-to-make-a-great-r-reproducible-example) -for the developers to investigate the problem. - ------------------------------------------------------------------------- - -### Error in x\$.self\$finalize() - -`pastclim` relies on `terra` to process rasters. There is a known bug in -`terra` that leads to the occasional message: - -``` -"Error in x$.self$finalize() : attempt to apply non-function" -``` - -This is an error related to garbage collection, which does not affect -the script being correctly executed, so it can be ignored. More -discussion of this issue can be found on -[stack**overflow**](https://stackoverflow.com/questions/61598340/why-does-rastertopoints-generate-an-error-on-first-call-but-not-second) +example](https://reprex.tidyverse.org/) +for the developers to investigate the problem. \ No newline at end of file diff --git a/cran-comments.md b/cran-comments.md index 46fd3263..3b728deb 100644 --- a/cran-comments.md +++ b/cran-comments.md @@ -14,4 +14,7 @@ there are failures with r-oldrel-macos-arm64 and r-oldrel-macos-x86-64. Old versions on mac of `terra`, on which `pastclim` relies, were problematic. This affected other packages as well: https://github.com/r-spatial/stars/issues/566 Pastclim works on r-oldrel-windows-x86-64, as well as on all other release and -devel versions. \ No newline at end of file +devel versions. + +There were notes on a r-devel, which picked up a man page where a parameters +was named incorrectly. That has been fixed in the current version. \ No newline at end of file diff --git a/data-raw/benchmark/benchmark.R b/data-raw/benchmark/benchmark.R new file mode 100644 index 00000000..5eff5c56 --- /dev/null +++ b/data-raw/benchmark/benchmark.R @@ -0,0 +1,22 @@ +library("pastclim") +library("tidysdm") +date <- seq(-600000, -620000, -4000) +tic("start") +climate <- region_series( + time_bp = date, + bio_variables = c("bio05", "bio06"), + dataset = "Krapp2021", + crop = region_outline$Europe +) +toc() + + +tic("start") +date <- -600000 +climate <- region_slice( + time_bp = date, + bio_variables = c("bio05", "bio06"), + dataset = "Krapp2021", + crop = region_outline$Europe +) +toc() diff --git a/data-raw/create_nc/update_meta_data_of_vars_in_nc.R b/data-raw/create_nc/update_meta_data_of_vars_in_nc.R deleted file mode 100644 index 019fc7a7..00000000 --- a/data-raw/create_nc/update_meta_data_of_vars_in_nc.R +++ /dev/null @@ -1,41 +0,0 @@ -#read.csv(system.file("rawdata_scripts/data_files/variable_table_complete_meta.csv", -# library="pastclim")) -library(ClimateOperators) -dataset <- "Krapp2021" -version_number <- "1.2.2" -out_dir <- "../../project_temp/past_climate/new_meta" -full_meta <- read.csv("./inst/rawdata_scripts/data_files/variable_table_complete_meta.csv") -data_path <- get_data_path() -sub_meta <- full_meta[full_meta$dataset == dataset,] -target_files <- unique(sub_meta$file_name) - -for (i in target_files){ - name_components<-unlist(strsplit(i,"_",fixed=TRUE)) - # replace the last component with new version - name_components<-name_components[-length(name_components)] - new_name <- paste(paste(name_components, collapse="_"),paste0("v", version_number,".nc"),sep="_") - new_target_path <- file.path(out_dir, new_name) - old_target_path <- file.path(get_data_path(),i) - file.copy(old_target_path,new_target_path) - nc_in <- ncdf4::nc_open(new_target_path, write = TRUE) - # update time units - ncdf4::ncatt_put(nc_in, varid="time", attname = "units", attval = "years since 1950-01-01 00:00:00.0") - ncdf4::ncatt_put(nc_in,varid="time", attname = "long_name",attval = "years BP") - # update meta units - this_var_names <- names(nc_in$var) - for (x in this_var_names){ - ncdf4::ncatt_put(nc_in, varid=x, attname = "long_name", - attval = sub_meta$long_name[sub_meta$ncvar==x]) - ncdf4::ncatt_put(nc_in, varid=x, attname = "units", - attval = sub_meta$units[sub_meta$ncvar==x]) - } - ncdf4::ncatt_put(nc_in, varid = 0, attname = "pastclim_version", - attval=version_number) - - ncdf4::nc_close(nc_in) - # now remove the attribute unit if present (it should be units) - for (x in this_var_names){ - ncatted(paste0('-a unit,',x,',d,, -h ',new_target_path)) - } - -} diff --git a/data-raw/data_files/dataset_list_included.csv b/data-raw/data_files/dataset_list_included.csv new file mode 100644 index 00000000..b15a2641 --- /dev/null +++ b/data-raw/data_files/dataset_list_included.csv @@ -0,0 +1,6530 @@ +variable,ncvar,dataset,monthly,file_name,download_path,download_function,file_name_orig,download_path_orig,version,long_name,abbreviated_name,time_frame,units,units_exp,dataset_list_v +bio01,BIO1,Example,FALSE,example_climate_v1.3.0.nc,,,,,1.3.0,annual mean temperature,ann. mean T,year,degrees Celsius,*degree*C*,1.3.9 +bio10,BIO10,Example,FALSE,example_climate_v1.3.0.nc,,,,,1.3.0,mean temperature of warmest quarter,mean T of warmest qtr,year,degrees Celsius,*degree*C*, +bio12,BIO12,Example,FALSE,example_climate_v1.3.0.nc,,,,,1.3.0,annual precipitation,ann. P,year,mm per year,*mm~yr^-1*, +biome,biome,Example,FALSE,example_climate_v1.3.0.nc,,,,,1.3.0,biome (from BIOME4),biome,year,,, +bio01,bio01,Beyer2020,FALSE,Beyer2020_annual_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_annual_vars_v1.2.2.nc?download=1,,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,annual mean temperature,ann. mean T,year,degrees Celsius,*degree*C*, +bio04,bio04,Beyer2020,FALSE,Beyer2020_annual_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_annual_vars_v1.2.2.nc?download=1,,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,temperature seasonality,T season.,year,degrees Celsius,*degree*C*, +bio05,bio05,Beyer2020,FALSE,Beyer2020_annual_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_annual_vars_v1.2.2.nc?download=1,,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,maximum temperature of warmest month,max. T of warmest mo.,year,degrees Celsius,*degree*C*, +bio06,bio06,Beyer2020,FALSE,Beyer2020_annual_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_annual_vars_v1.2.2.nc?download=1,,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,minimum temperature of coldest month,min. T of coldest mo.,year,degrees Celsius,*degree*C*, +bio07,bio07,Beyer2020,FALSE,Beyer2020_annual_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_annual_vars_v1.2.2.nc?download=1,,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,temperature annual range (bio05-bio06),T ann. Range,year,degrees Celsius,*degree*C*, +bio08,bio08,Beyer2020,FALSE,Beyer2020_annual_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_annual_vars_v1.2.2.nc?download=1,,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,mean temperature of wettest quarter,mean T of wettest qtr,year,degrees Celsius,*degree*C*, +bio09,bio09,Beyer2020,FALSE,Beyer2020_annual_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_annual_vars_v1.2.2.nc?download=1,,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,mean temperature of driest quarter,mean T of driest qtr,year,degrees Celsius,*degree*C*, +bio10,bio10,Beyer2020,FALSE,Beyer2020_annual_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_annual_vars_v1.2.2.nc?download=1,,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,mean temperature of warmest quarter,mean T of warmest qtr,year,degrees Celsius,*degree*C*, +bio11,bio11,Beyer2020,FALSE,Beyer2020_annual_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_annual_vars_v1.2.2.nc?download=1,,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,mean temperature of coldest quarter,mean T of coldest qtr,year,degrees Celsius,*degree*C*, +bio12,bio12,Beyer2020,FALSE,Beyer2020_annual_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_annual_vars_v1.2.2.nc?download=1,,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,annual precipitation,ann. P,year,mm per year,*mm~yr^-1*, +bio13,bio13,Beyer2020,FALSE,Beyer2020_annual_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_annual_vars_v1.2.2.nc?download=1,,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,precipitation of wettest month,P of wettest mo.,year,mm per month,*mm~mo^-1*, +bio14,bio14,Beyer2020,FALSE,Beyer2020_annual_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_annual_vars_v1.2.2.nc?download=1,,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,precipitation of driest month,P of driest mo.,year,mm per month,*mm~mo^-1*, +bio15,bio15,Beyer2020,FALSE,Beyer2020_annual_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_annual_vars_v1.2.2.nc?download=1,,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,precipitation seasonality (coeff var),P season.,year,,, +bio16,bio16,Beyer2020,FALSE,Beyer2020_annual_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_annual_vars_v1.2.2.nc?download=1,,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,precipitation of wettest quarter,P of wettest qtr,year,mm per quarter,*mm~qtr^-1*, +bio17,bio17,Beyer2020,FALSE,Beyer2020_annual_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_annual_vars_v1.2.2.nc?download=1,,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,precipitation of driest quarter,P of driest qtr,year,mm per quarter,*mm~qtr^-1*, +bio18,bio18,Beyer2020,FALSE,Beyer2020_annual_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_annual_vars_v1.2.2.nc?download=1,,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,precipitation of warmest quarter,P of warmest qtr,year,mm per quarter,*mm~qtr^-1*, +bio19,bio19,Beyer2020,FALSE,Beyer2020_annual_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_annual_vars_v1.2.2.nc?download=1,,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,precipitation of coldest quarter,P of coldest qtr,year,mm per quarter,*mm~qtr^-1*, +npp,npp,Beyer2020,FALSE,Beyer2020_annual_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_annual_vars_v1.2.2.nc?download=1,,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,net primary productivity,NPP,year,gC per m^2 per year,*gC~m^-2~yr^-1*, +lai,lai,Beyer2020,FALSE,Beyer2020_annual_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_annual_vars_v1.2.2.nc?download=1,,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,leaf area index,LAI,year,gC per m^2,*gC~m^-2*, +biome,biome,Beyer2020,FALSE,Beyer2020_annual_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_annual_vars_v1.2.2.nc?download=1,,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,biome (from BIOME4),biome,year,,, +altitude,altitude,Beyer2020,FALSE,Beyer2020_annual_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_annual_vars_v1.2.2.nc?download=1,,,,1.2.2,altitude over the sea level,altitude,year,meters,*m*, +rugosity,rugosity,Beyer2020,FALSE,Beyer2020_annual_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_annual_vars_v1.2.2.nc?download=1,,,,1.2.2,rugosity (st. dev. altitude at 1 min),rugosity,year,,, +temperature_01,temperature_01,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,mean temperature Jan,mean T Jan,january,degrees Celsius,*degree*C*, +temperature_02,temperature_02,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,mean temperature Feb,mean T Feb,february,degrees Celsius,*degree*C*, +temperature_03,temperature_03,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,mean temperature Mar,mean T Mar,march,degrees Celsius,*degree*C*, +temperature_04,temperature_04,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,mean temperature Apr,mean T Apr,april,degrees Celsius,*degree*C*, +temperature_05,temperature_05,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,mean temperature May,mean T May,may,degrees Celsius,*degree*C*, +temperature_06,temperature_06,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,mean temperature Jun,mean T Jun,june,degrees Celsius,*degree*C*, +temperature_07,temperature_07,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,mean temperature Jul,mean T Jul,july,degrees Celsius,*degree*C*, +temperature_08,temperature_08,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,mean temperature Aug,mean T Aug,august,degrees Celsius,*degree*C*, +temperature_09,temperature_09,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,mean temperature Sep,mean T Sep,september,degrees Celsius,*degree*C*, +temperature_10,temperature_10,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,mean temperature Oct,mean T Oct,october,degrees Celsius,*degree*C*, +temperature_11,temperature_11,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,mean temperature Nov,mean T Nov,november,degrees Celsius,*degree*C*, +temperature_12,temperature_12,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,mean temperature Dec,mean T Dec,december,degrees Celsius,*degree*C*, +precipitation_01,precipitation_01,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,precipitation Jan,P Jan,january,mm per month,*mm~mo^-1*, +precipitation_02,precipitation_02,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,precipitation Feb,P Feb,february,mm per month,*mm~mo^-1*, +precipitation_03,precipitation_03,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,precipitation Mar,P Mar,march,mm per month,*mm~mo^-1*, +precipitation_04,precipitation_04,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,precipitation Apr,P Apr,april,mm per month,*mm~mo^-1*, +precipitation_05,precipitation_05,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,precipitation May,P May,may,mm per month,*mm~mo^-1*, +precipitation_06,precipitation_06,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,precipitation Jun,P Jun,june,mm per month,*mm~mo^-1*, +precipitation_07,precipitation_07,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,precipitation Jul,P Jul,july,mm per month,*mm~mo^-1*, +precipitation_08,precipitation_08,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,precipitation Aug,P Aug,august,mm per month,*mm~mo^-1*, +precipitation_09,precipitation_09,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,precipitation Sep,P Sep,september,mm per month,*mm~mo^-1*, +precipitation_10,precipitation_10,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,precipitation Oct,P Oct,october,mm per month,*mm~mo^-1*, +precipitation_11,precipitation_11,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,precipitation Nov,P Nov,november,mm per month,*mm~mo^-1*, +precipitation_12,precipitation_12,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,precipitation Dec,P Dec,december,mm per month,*mm~mo^-1*, +cloudiness_01,cloudiness_01,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,cloudiness Jan,cloudiness Jan,january,%,*'%'*, +cloudiness_02,cloudiness_02,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,cloudiness Feb,cloudiness Feb,february,%,*'%'*, +cloudiness_03,cloudiness_03,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,cloudiness Mar,cloudiness Mar,march,%,*'%'*, +cloudiness_04,cloudiness_04,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,cloudiness Apr,cloudiness Apr,april,%,*'%'*, +cloudiness_05,cloudiness_05,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,cloudiness May,cloudiness May,may,%,*'%'*, +cloudiness_06,cloudiness_06,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,cloudiness Jun,cloudiness Jun,june,%,*'%'*, +cloudiness_07,cloudiness_07,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,cloudiness Jul,cloudiness Jul,july,%,*'%'*, +cloudiness_08,cloudiness_08,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,cloudiness Aug,cloudiness Aug,august,%,*'%'*, +cloudiness_09,cloudiness_09,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,cloudiness Sep,cloudiness Sep,september,%,*'%'*, +cloudiness_10,cloudiness_10,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,cloudiness Oct,cloudiness Oct,october,%,*'%'*, +cloudiness_11,cloudiness_11,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,cloudiness Nov,cloudiness Nov,november,%,*'%'*, +cloudiness_12,cloudiness_12,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,cloudiness Dec,cloudiness Dec,december,%,*'%'*, +relative_humidity_01,relative_humidity_01,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,relative humidity Jan,RH Jan,january,%,*'%'*, +relative_humidity_02,relative_humidity_02,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,relative humidity Feb,RH Feb,february,%,*'%'*, +relative_humidity_03,relative_humidity_03,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,relative humidity Mar,RH Mar,march,%,*'%'*, +relative_humidity_04,relative_humidity_04,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,relative humidity Apr,RH Apr,april,%,*'%'*, +relative_humidity_05,relative_humidity_05,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,relative humidity May,RH May,may,%,*'%'*, +relative_humidity_06,relative_humidity_06,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,relative humidity Jun,RH Jun,june,%,*'%'*, +relative_humidity_07,relative_humidity_07,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,relative humidity Jul,RH Jul,july,%,*'%'*, +relative_humidity_08,relative_humidity_08,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,relative humidity Aug,RH Aug,august,%,*'%'*, +relative_humidity_09,relative_humidity_09,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,relative humidity Sep,RH Sep,september,%,*'%'*, +relative_humidity_10,relative_humidity_10,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,relative humidity Oct,RH Oct,october,%,*'%'*, +relative_humidity_11,relative_humidity_11,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,relative humidity Nov,RH Nov,november,%,*'%'*, +relative_humidity_12,relative_humidity_12,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,relative humidity Dec,RH Dec,december,%,*'%'*, +wind_speed_01,wind_speed_01,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,wind speed Jan,WS Jan,january,m per second,*m~s^-1*, +wind_speed_02,wind_speed_02,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,wind speed Feb,WS Feb,february,m per second,*m~s^-1*, +wind_speed_03,wind_speed_03,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,wind speed Mar,WS Mar,march,m per second,*m~s^-1*, +wind_speed_04,wind_speed_04,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,wind speed Apr,WS Apr,april,m per second,*m~s^-1*, +wind_speed_05,wind_speed_05,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,wind speed May,WS May,may,m per second,*m~s^-1*, +wind_speed_06,wind_speed_06,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,wind speed Jun,WS Jun,june,m per second,*m~s^-1*, +wind_speed_07,wind_speed_07,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,wind speed Jul,WS Jul,july,m per second,*m~s^-1*, +wind_speed_08,wind_speed_08,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,wind speed Aug,WS Aug,august,m per second,*m~s^-1*, +wind_speed_09,wind_speed_09,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,wind speed Sep,WS Sep,september,m per second,*m~s^-1*, +wind_speed_10,wind_speed_10,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,wind speed Oct,WS Oct,october,m per second,*m~s^-1*, +wind_speed_11,wind_speed_11,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,wind speed Nov,WS Nov,november,m per second,*m~s^-1*, +wind_speed_12,wind_speed_12,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,wind speed Dec,WS Dec,december,m per second,*m~s^-1*, +mo_npp_01,mo_npp_01,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,net primary productivity Jan,NPP Jan,january,gC per m^2 per month,*gC~m^-2~mo^-1*, +mo_npp_02,mo_npp_02,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,net primary productivity Feb,NPP Feb,february,gC per m^2 per month,*gC~m^-2~mo^-1*, +mo_npp_03,mo_npp_03,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,net primary productivity Mar,NPP Mar,march,gC per m^2 per month,*gC~m^-2~mo^-1*, +mo_npp_04,mo_npp_04,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,net primary productivity Apr,NPP Apr,april,gC per m^2 per month,*gC~m^-2~mo^-1*, +mo_npp_05,mo_npp_05,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,net primary productivity May,NPP May,may,gC per m^2 per month,*gC~m^-2~mo^-1*, +mo_npp_06,mo_npp_06,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,net primary productivity Jun,NPP Jun,june,gC per m^2 per month,*gC~m^-2~mo^-1*, +mo_npp_07,mo_npp_07,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,net primary productivity Jul,NPP Jul,july,gC per m^2 per month,*gC~m^-2~mo^-1*, +mo_npp_08,mo_npp_08,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,net primary productivity Aug,NPP Aug,august,gC per m^2 per month,*gC~m^-2~mo^-1*, +mo_npp_09,mo_npp_09,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,net primary productivity Sep,NPP Sep,september,gC per m^2 per month,*gC~m^-2~mo^-1*, +mo_npp_10,mo_npp_10,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,net primary productivity Oct,NPP Oct,october,gC per m^2 per month,*gC~m^-2~mo^-1*, +mo_npp_11,mo_npp_11,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,net primary productivity Nov,NPP Nov,november,gC per m^2 per month,*gC~m^-2~mo^-1*, +mo_npp_12,mo_npp_12,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,net primary productivity Dec,NPP Dec,december,gC per m^2 per month,*gC~m^-2~mo^-1*, +bio01,bio01,Krapp2021,FALSE,Krapp2021_bio01_v1.4.0.nc,https://zenodo.org/record/8415273/files/Krapp2021_bio01_v1.4.0.nc?download=1,,bio01_800ka.nc,https://osf.io/a39gh/?action=download,1.4.0,annual mean temperature,ann. mean T,year,degrees Celsius,*degree*C*, +bio04,bio04,Krapp2021,FALSE,Krapp2021_bio04_v1.4.0.nc,https://zenodo.org/record/8415273/files/Krapp2021_bio04_v1.4.0.nc?download=1,,bio04_800ka.nc,https://osf.io/p82ue/?action=download,1.4.0,temperature seasonality,T season.,year,degrees Celsius,*degree*C*, +bio05,bio05,Krapp2021,FALSE,Krapp2021_bio05_v1.4.0.nc,https://zenodo.org/record/8415273/files/Krapp2021_bio05_v1.4.0.nc?download=1,,bio05_800ka.nc,https://osf.io/emhp9/?action=download,1.4.0,maximum temperature of warmest month,maximum T of warmest mo.,year,degrees Celsius,*degree*C*, +bio06,bio06,Krapp2021,FALSE,Krapp2021_bio06_v1.4.0.nc,https://zenodo.org/record/8415273/files/Krapp2021_bio06_v1.4.0.nc?download=1,,bio06_800ka.nc,https://osf.io/cm923/?action=download,1.4.0,minimum temperature of coldest month,minimum T of coldest mo.,year,degrees Celsius,*degree*C*, +bio07,bio07,Krapp2021,FALSE,Krapp2021_bio07_v1.4.0.nc,https://zenodo.org/record/8415273/files/Krapp2021_bio07_v1.4.0.nc?download=1,,bio07_800ka.nc,https://osf.io/prq8n/?action=download,1.4.0,temperature annual range (bio05-bio06),T ann. range (bio05-bio06),year,degrees Celsius,*degree*C*, +bio08,bio08,Krapp2021,FALSE,Krapp2021_bio08_v1.4.0.nc,https://zenodo.org/record/8415273/files/Krapp2021_bio08_v1.4.0.nc?download=1,,bio08_800ka.nc,https://osf.io/7jsa8/?action=download,1.4.0,mean temperature of wettest quarter,mean T of wettest qtr,year,degrees Celsius,*degree*C*, +bio09,bio09,Krapp2021,FALSE,Krapp2021_bio09_v1.4.0.nc,https://zenodo.org/record/8415273/files/Krapp2021_bio09_v1.4.0.nc?download=1,,bio09_800ka.nc,https://osf.io/zaxku/?action=download,1.4.0,mean temperature of driest quarter,mean T of driest qtr,year,degrees Celsius,*degree*C*, +bio10,bio10,Krapp2021,FALSE,Krapp2021_bio10_v1.4.0.nc,https://zenodo.org/record/8415273/files/Krapp2021_bio10_v1.4.0.nc?download=1,,bio10_800ka.nc,https://osf.io/b3kx8/?action=download,1.4.0,mean temperature of warmest quarter,mean T of warmest qtr,year,degrees Celsius,*degree*C*, +bio11,bio11,Krapp2021,FALSE,Krapp2021_bio11_v1.4.0.nc,https://zenodo.org/record/8415273/files/Krapp2021_bio11_v1.4.0.nc?download=1,,bio11_800ka.nc,https://osf.io/vaune/?action=download,1.4.0,mean temperature of coldest quarter,mean T of coldest qtr,year,degrees Celsius,*degree*C*, +bio12,bio12,Krapp2021,FALSE,Krapp2021_bio12_v1.4.0.nc,https://zenodo.org/record/8415273/files/Krapp2021_bio12_v1.4.0.nc?download=1,,bio12_800ka.nc,https://osf.io/kg9v6/?action=download,1.4.0,annual precipitation,ann. P,year,mm per year,*mm~yr^-1*, +bio13,bio13,Krapp2021,FALSE,Krapp2021_bio13_v1.4.0.nc,https://zenodo.org/record/8415273/files/Krapp2021_bio13_v1.4.0.nc?download=1,,bio13_800ka.nc,https://osf.io/2u5c6/?action=download,1.4.0,precipitation of wettest month,P of wettest mo.,year,mm per month,*mm~mo^-1*, +bio14,bio14,Krapp2021,FALSE,Krapp2021_bio14_v1.4.0.nc,https://zenodo.org/record/8415273/files/Krapp2021_bio14_v1.4.0.nc?download=1,,bio14_800ka.nc,https://osf.io/z2ewu/?action=download,1.4.0,precipitation of driest month,P of driest mo.,year,mm per month,*mm~mo^-1*, +bio15,bio15,Krapp2021,FALSE,Krapp2021_bio15_v1.4.0.nc,https://zenodo.org/record/8415273/files/Krapp2021_bio15_v1.4.0.nc?download=1,,bio15_800ka.nc,https://osf.io/z52xr/?action=download,1.4.0,precipitation seasonality (coefficient of variation),P season. (coefficient of variation),year,,, +bio16,bio16,Krapp2021,FALSE,Krapp2021_bio16_v1.4.0.nc,https://zenodo.org/record/8415273/files/Krapp2021_bio16_v1.4.0.nc?download=1,,bio16_800ka.nc,https://osf.io/kn8ma/?action=download,1.4.0,precipitation of wettest quarter,P of wettest qtr,year,mm per quarter,*mm~qtr^-1*, +bio17,bio17,Krapp2021,FALSE,Krapp2021_bio17_v1.4.0.nc,https://zenodo.org/record/8415273/files/Krapp2021_bio17_v1.4.0.nc?download=1,,bio17_800ka.nc,https://osf.io/2z8ej/?action=download,1.4.0,precipitation of driest quarter,P of driest qtr,year,mm per quarter,*mm~qtr^-1*, +bio18,bio18,Krapp2021,FALSE,Krapp2021_bio18_v1.4.0.nc,https://zenodo.org/record/8415273/files/Krapp2021_bio18_v1.4.0.nc?download=1,,bio18_800ka.nc,https://osf.io/a2uhm/?action=download,1.4.0,precipitation of warmest quarter,P of warmest qtr,year,mm per quarter,*mm~qtr^-1*, +bio19,bio19,Krapp2021,FALSE,Krapp2021_bio19_v1.4.0.nc,https://zenodo.org/record/8415273/files/Krapp2021_bio19_v1.4.0.nc?download=1,,bio19_800ka.nc,https://osf.io/3mbd9/?action=download,1.4.0,precipitation of coldest quarter,P of coldest qtr,year,mm per quarter,*mm~qtr^-1*, +npp,npp,Krapp2021,FALSE,Krapp2021_npp_v1.2.2.nc,https://zenodo.org/record/8415273/files/Krapp2021_npp_v1.2.2.nc?download=1,,biome4output_800ka.nc,https://osf.io/cf5zp/?action=download,1.2.2,net primary productivity,NPP,year,gC per m^2 per year,*gC~m^-2~yr^-1*, +biome,biome,Krapp2021,FALSE,Krapp2021_biome_v1.2.2.nc,https://zenodo.org/record/8415273/files/Krapp2021_biome_v1.2.2.nc?download=1,,biome4output_800ka.nc,https://osf.io/cf5zp/?action=download,1.2.2,biome (from BIOME4),biome (from BIOME4),year,,, +lai,lai,Krapp2021,FALSE,Krapp2021_lai_v1.2.3.nc,https://zenodo.org/record/7434553/files/Krapp2021_lai_v1.2.3.nc?download=1,,biome4output_800ka.nc,https://osf.io/cf5zp/?action=download,1.2.2,leaf area index,LAI,year,gC per m^2,*gC~m^-2*, +altitude,altitude,Krapp2021,FALSE,Krapp2021_topography_v1.2.2.nc,https://zenodo.org/record/8415273/files/Krapp2021_topography_v1.2.2.nc?download=1,,,,1.2.2,altitude over the sea level,altitude over the sea level,year,m,*m*, +rugosity,rugosity,Krapp2021,FALSE,Krapp2021_topography_v1.2.2.nc,https://zenodo.org/record/8415273/files/Krapp2021_topography_v1.2.2.nc?download=1,,,,1.2.2,rugosity,rugosity,year,,, +temperature_01,temp_01,Krapp2021,TRUE,Krapp2021_temp_monthly_v1.4.0.nc,https://zenodo.org/record/8415273/files/Krapp2021_temp_monthly_v1.4.0.nc?download=1,,,,1.4.0,mean temperature Jan,mean T Jan,january,degrees Celsius,*degree*C*, +temperature_02,temp_02,Krapp2021,TRUE,Krapp2021_temp_monthly_v1.4.0.nc,https://zenodo.org/record/8415273/files/Krapp2021_temp_monthly_v1.4.0.nc?download=1,,,,1.4.0,mean temperature Feb,mean T Feb,february,degrees Celsius,*degree*C*, +temperature_03,temp_03,Krapp2021,TRUE,Krapp2021_temp_monthly_v1.4.0.nc,https://zenodo.org/record/8415273/files/Krapp2021_temp_monthly_v1.4.0.nc?download=1,,,,1.4.0,mean temperature Mar,mean T Mar,march,degrees Celsius,*degree*C*, +temperature_04,temp_04,Krapp2021,TRUE,Krapp2021_temp_monthly_v1.4.0.nc,https://zenodo.org/record/8415273/files/Krapp2021_temp_monthly_v1.4.0.nc?download=1,,,,1.4.0,mean temperature Apr,mean T Apr,april,degrees Celsius,*degree*C*, +temperature_05,temp_05,Krapp2021,TRUE,Krapp2021_temp_monthly_v1.4.0.nc,https://zenodo.org/record/8415273/files/Krapp2021_temp_monthly_v1.4.0.nc?download=1,,,,1.4.0,mean temperature May,mean T May,may,degrees Celsius,*degree*C*, +temperature_06,temp_06,Krapp2021,TRUE,Krapp2021_temp_monthly_v1.4.0.nc,https://zenodo.org/record/8415273/files/Krapp2021_temp_monthly_v1.4.0.nc?download=1,,,,1.4.0,mean temperature Jun,mean T Jun,june,degrees Celsius,*degree*C*, +temperature_07,temp_07,Krapp2021,TRUE,Krapp2021_temp_monthly_v1.4.0.nc,https://zenodo.org/record/8415273/files/Krapp2021_temp_monthly_v1.4.0.nc?download=1,,,,1.4.0,mean temperature Jul,mean T Jul,july,degrees Celsius,*degree*C*, +temperature_08,temp_08,Krapp2021,TRUE,Krapp2021_temp_monthly_v1.4.0.nc,https://zenodo.org/record/8415273/files/Krapp2021_temp_monthly_v1.4.0.nc?download=1,,,,1.4.0,mean temperature Aug,mean T Aug,august,degrees Celsius,*degree*C*, +temperature_09,temp_09,Krapp2021,TRUE,Krapp2021_temp_monthly_v1.4.0.nc,https://zenodo.org/record/8415273/files/Krapp2021_temp_monthly_v1.4.0.nc?download=1,,,,1.4.0,mean temperature Sep,mean T Sep,september,degrees Celsius,*degree*C*, +temperature_10,temp_10,Krapp2021,TRUE,Krapp2021_temp_monthly_v1.4.0.nc,https://zenodo.org/record/8415273/files/Krapp2021_temp_monthly_v1.4.0.nc?download=1,,,,1.4.0,mean temperature Oct,mean T Oct,october,degrees Celsius,*degree*C*, +temperature_11,temp_11,Krapp2021,TRUE,Krapp2021_temp_monthly_v1.4.0.nc,https://zenodo.org/record/8415273/files/Krapp2021_temp_monthly_v1.4.0.nc?download=1,,,,1.4.0,mean temperature Nov,mean T Nov,november,degrees Celsius,*degree*C*, +temperature_12,temp_12,Krapp2021,TRUE,Krapp2021_temp_monthly_v1.4.0.nc,https://zenodo.org/record/8415273/files/Krapp2021_temp_monthly_v1.4.0.nc?download=1,,,,1.4.0,mean temperature Dec,mean T Dec,december,degrees Celsius,*degree*C*, +precipitation_01,prec_01,Krapp2021,TRUE,Krapp2021_prec_monthly_v1.4.0.nc,https://zenodo.org/record/8415273/files/Krapp2021_prec_monthly_v1.4.0.nc?download=1,,,,1.4.0,precipitation Jan,P Jan,january,mm per month,*mm~mo^-1*, +precipitation_02,prec_02,Krapp2021,TRUE,Krapp2021_prec_monthly_v1.4.0.nc,https://zenodo.org/record/8415273/files/Krapp2021_prec_monthly_v1.4.0.nc?download=1,,,,1.4.0,precipitation Feb,P Feb,february,mm per month,*mm~mo^-1*, +precipitation_03,prec_03,Krapp2021,TRUE,Krapp2021_prec_monthly_v1.4.0.nc,https://zenodo.org/record/8415273/files/Krapp2021_prec_monthly_v1.4.0.nc?download=1,,,,1.4.0,precipitation Mar,P Mar,march,mm per month,*mm~mo^-1*, +precipitation_04,prec_04,Krapp2021,TRUE,Krapp2021_prec_monthly_v1.4.0.nc,https://zenodo.org/record/8415273/files/Krapp2021_prec_monthly_v1.4.0.nc?download=1,,,,1.4.0,precipitation Apr,P Apr,april,mm per month,*mm~mo^-1*, +precipitation_05,prec_05,Krapp2021,TRUE,Krapp2021_prec_monthly_v1.4.0.nc,https://zenodo.org/record/8415273/files/Krapp2021_prec_monthly_v1.4.0.nc?download=1,,,,1.4.0,precipitation May,P May,may,mm per month,*mm~mo^-1*, +precipitation_06,prec_06,Krapp2021,TRUE,Krapp2021_prec_monthly_v1.4.0.nc,https://zenodo.org/record/8415273/files/Krapp2021_prec_monthly_v1.4.0.nc?download=1,,,,1.4.0,precipitation Jun,P Jun,june,mm per month,*mm~mo^-1*, +precipitation_07,prec_07,Krapp2021,TRUE,Krapp2021_prec_monthly_v1.4.0.nc,https://zenodo.org/record/8415273/files/Krapp2021_prec_monthly_v1.4.0.nc?download=1,,,,1.4.0,precipitation Jul,P Jul,july,mm per month,*mm~mo^-1*, +precipitation_08,prec_08,Krapp2021,TRUE,Krapp2021_prec_monthly_v1.4.0.nc,https://zenodo.org/record/8415273/files/Krapp2021_prec_monthly_v1.4.0.nc?download=1,,,,1.4.0,precipitation Aug,P Aug,august,mm per month,*mm~mo^-1*, +precipitation_09,prec_09,Krapp2021,TRUE,Krapp2021_prec_monthly_v1.4.0.nc,https://zenodo.org/record/8415273/files/Krapp2021_prec_monthly_v1.4.0.nc?download=1,,,,1.4.0,precipitation Sep,P Sep,september,mm per month,*mm~mo^-1*, +precipitation_10,prec_10,Krapp2021,TRUE,Krapp2021_prec_monthly_v1.4.0.nc,https://zenodo.org/record/8415273/files/Krapp2021_prec_monthly_v1.4.0.nc?download=1,,,,1.4.0,precipitation Oct,P Oct,october,mm per month,*mm~mo^-1*, +precipitation_11,prec_11,Krapp2021,TRUE,Krapp2021_prec_monthly_v1.4.0.nc,https://zenodo.org/record/8415273/files/Krapp2021_prec_monthly_v1.4.0.nc?download=1,,,,1.4.0,precipitation Nov,P Nov,november,mm per month,*mm~mo^-1*, +precipitation_12,prec_12,Krapp2021,TRUE,Krapp2021_prec_monthly_v1.4.0.nc,https://zenodo.org/record/8415273/files/Krapp2021_prec_monthly_v1.4.0.nc?download=1,,,,1.4.0,precipitation Dec,P Dec,december,mm per month,*mm~mo^-1*, +mo_npp_01,mo_npp_01,Krapp2021,TRUE,Krapp2021_npp_monthly_v1.2.2.nc,https://zenodo.org/record/8415273/files/Krapp2021_npp_monthly_v1.2.2.nc?download=1,,,,1.2.2,net primary productivity Jan,NPP Jan,january,gC per m^2 per month,*gC~m^-2~mo^-1*, +mo_npp_02,mo_npp_02,Krapp2021,TRUE,Krapp2021_npp_monthly_v1.2.2.nc,https://zenodo.org/record/8415273/files/Krapp2021_npp_monthly_v1.2.2.nc?download=1,,,,1.2.2,net primary productivity Feb,NPP Feb,february,gC per m^2 per month,*gC~m^-2~mo^-1*, +mo_npp_03,mo_npp_03,Krapp2021,TRUE,Krapp2021_npp_monthly_v1.2.2.nc,https://zenodo.org/record/8415273/files/Krapp2021_npp_monthly_v1.2.2.nc?download=1,,,,1.2.2,net primary productivity Mar,NPP Mar,march,gC per m^2 per month,*gC~m^-2~mo^-1*, +mo_npp_04,mo_npp_04,Krapp2021,TRUE,Krapp2021_npp_monthly_v1.2.2.nc,https://zenodo.org/record/8415273/files/Krapp2021_npp_monthly_v1.2.2.nc?download=1,,,,1.2.2,net primary productivity Apr,NPP Apr,april,gC per m^2 per month,*gC~m^-2~mo^-1*, +mo_npp_05,mo_npp_05,Krapp2021,TRUE,Krapp2021_npp_monthly_v1.2.2.nc,https://zenodo.org/record/8415273/files/Krapp2021_npp_monthly_v1.2.2.nc?download=1,,,,1.2.2,net primary productivity May,NPP May,may,gC per m^2 per month,*gC~m^-2~mo^-1*, +mo_npp_06,mo_npp_06,Krapp2021,TRUE,Krapp2021_npp_monthly_v1.2.2.nc,https://zenodo.org/record/8415273/files/Krapp2021_npp_monthly_v1.2.2.nc?download=1,,,,1.2.2,net primary productivity Jun,NPP Jun,june,gC per m^2 per month,*gC~m^-2~mo^-1*, +mo_npp_07,mo_npp_07,Krapp2021,TRUE,Krapp2021_npp_monthly_v1.2.2.nc,https://zenodo.org/record/8415273/files/Krapp2021_npp_monthly_v1.2.2.nc?download=1,,,,1.2.2,net primary productivity Jul,NPP Jul,july,gC per m^2 per month,*gC~m^-2~mo^-1*, +mo_npp_08,mo_npp_08,Krapp2021,TRUE,Krapp2021_npp_monthly_v1.2.2.nc,https://zenodo.org/record/8415273/files/Krapp2021_npp_monthly_v1.2.2.nc?download=1,,,,1.2.2,net primary productivity Aug,NPP Aug,august,gC per m^2 per month,*gC~m^-2~mo^-1*, +mo_npp_09,mo_npp_09,Krapp2021,TRUE,Krapp2021_npp_monthly_v1.2.2.nc,https://zenodo.org/record/8415273/files/Krapp2021_npp_monthly_v1.2.2.nc?download=1,,,,1.2.2,net primary productivity Sep,NPP Sep,september,gC per m^2 per month,*gC~m^-2~mo^-1*, +mo_npp_10,mo_npp_10,Krapp2021,TRUE,Krapp2021_npp_monthly_v1.2.2.nc,https://zenodo.org/record/8415273/files/Krapp2021_npp_monthly_v1.2.2.nc?download=1,,,,1.2.2,net primary productivity Oct,NPP Oct,october,gC per m^2 per month,*gC~m^-2~mo^-1*, +mo_npp_11,mo_npp_11,Krapp2021,TRUE,Krapp2021_npp_monthly_v1.2.2.nc,https://zenodo.org/record/8415273/files/Krapp2021_npp_monthly_v1.2.2.nc?download=1,,,,1.2.2,net primary productivity Nov,NPP Nov,november,gC per m^2 per month,*gC~m^-2~mo^-1*, +mo_npp_12,mo_npp_12,Krapp2021,TRUE,Krapp2021_npp_monthly_v1.2.2.nc,https://zenodo.org/record/8415273/files/Krapp2021_npp_monthly_v1.2.2.nc?download=1,,,,1.2.2,net primary productivity Dec,NPP Dec,december,gC per m^2 per month,*gC~m^-2~mo^-1*, +cloudiness_01,tcc_01,Krapp2021,TRUE,Krapp2021_tcc_monthly_v1.2.2.nc,https://zenodo.org/record/8415273/files/Krapp2021_tcc_monthly_v1.2.2.nc?download=1,,,,1.2.2,cloudiness Jan,cloudiness Jan,january,%,*'%'*, +cloudiness_02,tcc_02,Krapp2021,TRUE,Krapp2021_tcc_monthly_v1.2.2.nc,https://zenodo.org/record/8415273/files/Krapp2021_tcc_monthly_v1.2.2.nc?download=1,,,,1.2.2,cloudiness Feb,cloudiness Feb,february,%,*'%'*, +cloudiness_03,tcc_03,Krapp2021,TRUE,Krapp2021_tcc_monthly_v1.2.2.nc,https://zenodo.org/record/8415273/files/Krapp2021_tcc_monthly_v1.2.2.nc?download=1,,,,1.2.2,cloudiness Mar,cloudiness Mar,march,%,*'%'*, +cloudiness_04,tcc_04,Krapp2021,TRUE,Krapp2021_tcc_monthly_v1.2.2.nc,https://zenodo.org/record/8415273/files/Krapp2021_tcc_monthly_v1.2.2.nc?download=1,,,,1.2.2,cloudiness Apr,cloudiness Apr,april,%,*'%'*, +cloudiness_05,tcc_05,Krapp2021,TRUE,Krapp2021_tcc_monthly_v1.2.2.nc,https://zenodo.org/record/8415273/files/Krapp2021_tcc_monthly_v1.2.2.nc?download=1,,,,1.2.2,cloudiness May,cloudiness May,may,%,*'%'*, +cloudiness_06,tcc_06,Krapp2021,TRUE,Krapp2021_tcc_monthly_v1.2.2.nc,https://zenodo.org/record/8415273/files/Krapp2021_tcc_monthly_v1.2.2.nc?download=1,,,,1.2.2,cloudiness Jun,cloudiness Jun,june,%,*'%'*, +cloudiness_07,tcc_07,Krapp2021,TRUE,Krapp2021_tcc_monthly_v1.2.2.nc,https://zenodo.org/record/8415273/files/Krapp2021_tcc_monthly_v1.2.2.nc?download=1,,,,1.2.2,cloudiness Jul,cloudiness Jul,july,%,*'%'*, +cloudiness_08,tcc_08,Krapp2021,TRUE,Krapp2021_tcc_monthly_v1.2.2.nc,https://zenodo.org/record/8415273/files/Krapp2021_tcc_monthly_v1.2.2.nc?download=1,,,,1.2.2,cloudiness Aug,cloudiness Aug,august,%,*'%'*, +cloudiness_09,tcc_09,Krapp2021,TRUE,Krapp2021_tcc_monthly_v1.2.2.nc,https://zenodo.org/record/8415273/files/Krapp2021_tcc_monthly_v1.2.2.nc?download=1,,,,1.2.2,cloudiness Sep,cloudiness Sep,september,%,*'%'*, +cloudiness_10,tcc_10,Krapp2021,TRUE,Krapp2021_tcc_monthly_v1.2.2.nc,https://zenodo.org/record/8415273/files/Krapp2021_tcc_monthly_v1.2.2.nc?download=1,,,,1.2.2,cloudiness Oct,cloudiness Oct,october,%,*'%'*, +cloudiness_11,tcc_11,Krapp2021,TRUE,Krapp2021_tcc_monthly_v1.2.2.nc,https://zenodo.org/record/8415273/files/Krapp2021_tcc_monthly_v1.2.2.nc?download=1,,,,1.2.2,cloudiness Nov,cloudiness Nov,november,%,*'%'*, +cloudiness_12,tcc_12,Krapp2021,TRUE,Krapp2021_tcc_monthly_v1.2.2.nc,https://zenodo.org/record/8415273/files/Krapp2021_tcc_monthly_v1.2.2.nc?download=1,,,,1.2.2,cloudiness Dec,cloudiness Dec,december,%,*'%'*, +bio01,PALEO-PGEM-Series_bio1_mean,Barreto2023,FALSE,PALEO-PGEM-Series_bio1_mean.nc,https://figshare.com/ndownloader/files/42383337,,bio1_mean.txt,https://figshare.com/ndownloader/files/36469758,1.0.0,annual mean temperature (mean over 10 stochastic GCM emulations),ann. mean T,year,degrees Celsius,*degree*C*, +bio04,PALEO-PGEM-Series_bio4_mean,Barreto2023,FALSE,PALEO-PGEM-Series_bio4_mean.nc,https://figshare.com/ndownloader/files/42383346,,bio4_mean.txt,https://figshare.com/ndownloader/files/36469758,1.0.0,temperature seasonality (mean over 10 stochastic GCM emulations),T season.,year,degrees Celsius,*degree*C*, +bio05,PALEO-PGEM-Series_bio5_mean,Barreto2023,FALSE,PALEO-PGEM-Series_bio5_mean.nc,https://figshare.com/ndownloader/files/42383301,,bio5_mean.txt,https://figshare.com/ndownloader/files/36469758,1.0.0,maximum temperature of warmest month (mean over 10 stochastic GCM emulations),max. T of warmest mo.,year,degrees Celsius,*degree*C*, +bio06,PALEO-PGEM-Series_bio6_mean,Barreto2023,FALSE,PALEO-PGEM-Series_bio6_mean.nc,https://figshare.com/ndownloader/files/42383304,,bio6_mean.txt,https://figshare.com/ndownloader/files/36469758,1.0.0,minimum temperature of coldest month (mean over 10 stochastic GCM emulations),min. T of coldest mo.,year,degrees Celsius,*degree*C*, +bio07,PALEO-PGEM-Series_bio7_mean,Barreto2023,FALSE,PALEO-PGEM-Series_bio7_mean.nc,https://figshare.com/ndownloader/files/42383307,,bio7_mean.txt,https://figshare.com/ndownloader/files/36469758,1.0.0,temperature annual range (bio05-bio06) (mean over 10 stochastic GCM emulations),T ann. Range,year,degrees Celsius,*degree*C*, +bio08,PALEO-PGEM-Series_bio8_mean,Barreto2023,FALSE,PALEO-PGEM-Series_bio8_mean.nc,https://figshare.com/ndownloader/files/42383316,,bio8_mean.txt,https://figshare.com/ndownloader/files/36469758,1.0.0,mean temperature of wettest quarter (mean over 10 stochastic GCM emulations),mean T of wettest qtr,year,degrees Celsius,*degree*C*, +bio09,PALEO-PGEM-Series_bio9_mean,Barreto2023,FALSE,PALEO-PGEM-Series_bio9_mean.nc,https://figshare.com/ndownloader/files/42383313,,bio9_mean.txt,https://figshare.com/ndownloader/files/36469758,1.0.0,mean temperature of driest quarter (mean over 10 stochastic GCM emulations),mean T of driest qtr,year,degrees Celsius,*degree*C*, +bio10,PALEO-PGEM-Series_bio10_mean,Barreto2023,FALSE,PALEO-PGEM-Series_bio10_mean.nc,https://figshare.com/ndownloader/files/42383319,,bio10_mean.txt,https://figshare.com/ndownloader/files/36469758,1.0.0,mean temperature of warmest quarter (mean over 10 stochastic GCM emulations),mean T of warmest qtr,year,degrees Celsius,*degree*C*, +bio11,PALEO-PGEM-Series_bio11_mean,Barreto2023,FALSE,PALEO-PGEM-Series_bio11_mean.nc,https://figshare.com/ndownloader/files/42383322,,bio11_mean.txt,https://figshare.com/ndownloader/files/36469758,1.0.0,mean temperature of coldest quarter (mean over 10 stochastic GCM emulations),mean T of coldest qtr,year,degrees Celsius,*degree*C*, +bio12,PALEO-PGEM-Series_bio12_mean,Barreto2023,FALSE,PALEO-PGEM-Series_bio12_mean.nc,https://figshare.com/ndownloader/files/42383343,,bio12_mean.txt,https://figshare.com/ndownloader/files/36469758,1.0.0,annual precipitation (mean over 10 stochastic GCM emulations),ann. P,year,mm per year,*mm~yr^-1*, +bio13,PALEO-PGEM-Series_bio13_mean,Barreto2023,FALSE,PALEO-PGEM-Series_bio13_mean.nc,https://figshare.com/ndownloader/files/42383331,,bio13_mean.txt,https://figshare.com/ndownloader/files/36469758,1.0.0,precipitation of wettest month (mean over 10 stochastic GCM emulations),P of wettest mo.,year,mm per month,*mm~mo^-1*, +bio14,PALEO-PGEM-Series_bio14_mean,Barreto2023,FALSE,PALEO-PGEM-Series_bio14_mean.nc,https://figshare.com/ndownloader/files/42383310,,bio14_mean.txt,https://figshare.com/ndownloader/files/36469758,1.0.0,precipitation of driest month (mean over 10 stochastic GCM emulations),P of driest mo.,year,mm per month,*mm~mo^-1*, +bio15,PALEO-PGEM-Series_bio15_mean,Barreto2023,FALSE,PALEO-PGEM-Series_bio15_mean.nc,https://figshare.com/ndownloader/files/42383349,,bio15_mean.txt,https://figshare.com/ndownloader/files/36469758,1.0.0,precipitation seasonality (coeff var) (mean over 10 stochastic GCM emulations),P season.,year,,, +bio16,PALEO-PGEM-Series_bio16_mean,Barreto2023,FALSE,PALEO-PGEM-Series_bio16_mean.nc,https://figshare.com/ndownloader/files/42383340,,bio16_mean.txt,https://figshare.com/ndownloader/files/36469758,1.0.0,precipitation of wettest quarter (mean over 10 stochastic GCM emulations),P of wettest qtr,year,mm per quarter,*mm~qtr^-1*, +bio17,PALEO-PGEM-Series_bio17_mean,Barreto2023,FALSE,PALEO-PGEM-Series_bio17_mean.nc,https://figshare.com/ndownloader/files/42383325,,bio17_mean.txt,https://figshare.com/ndownloader/files/36469758,1.0.0,precipitation of driest quarter (mean over 10 stochastic GCM emulations),P of driest qtr,year,mm per quarter,*mm~qtr^-1*, +bio18,PALEO-PGEM-Series_bio18_mean,Barreto2023,FALSE,PALEO-PGEM-Series_bio18_mean.nc,https://figshare.com/ndownloader/files/42383334,,bio18_mean.txt,https://figshare.com/ndownloader/files/36469758,1.0.0,precipitation of warmest quarter (mean over 10 stochastic GCM emulations),P of warmest qtr,year,mm per quarter,*mm~qtr^-1*, +bio19,PALEO-PGEM-Series_bio19_mean,Barreto2023,FALSE,PALEO-PGEM-Series_bio19_mean.nc,https://figshare.com/ndownloader/files/42383328,,bio19_mean.txt,https://figshare.com/ndownloader/files/36469758,1.0.0,precipitation of coldest quarter (mean over 10 stochastic GCM emulations),P of coldest qtr,year,mm per quarter,*mm~qtr^-1*, +temperature_01,PALEO-PGEM-Series_monthly_temperature01_mean,Barreto2023,TRUE,PALEO-PGEM-Series_monthly_temperature01_mean.nc,https://figshare.com/ndownloader/files/42383673,,monthly_temperature01M,https://figshare.com/ndownloader/files/36426117,1.0.0,mean monthly temperature Jan over 10 stochastic GCM emulations,mean T Jan,january,degrees Celsius,*degree*C*, +temperature_02,PALEO-PGEM-Series_monthly_temperature02_mean,Barreto2023,TRUE,PALEO-PGEM-Series_monthly_temperature02_mean.nc,https://figshare.com/ndownloader/files/42383679,,monthly_temperature02M,https://figshare.com/ndownloader/files/36426117,1.0.0,mean monthly temperature Feb over 10 stochastic GCM emulations,mean T Feb,february,degrees Celsius,*degree*C*, +temperature_03,PALEO-PGEM-Series_monthly_temperature03_mean,Barreto2023,TRUE,PALEO-PGEM-Series_monthly_temperature03_mean.nc,https://figshare.com/ndownloader/files/42383661,,monthly_temperature03M,https://figshare.com/ndownloader/files/36426117,1.0.0,mean monthly temperature Mar over 10 stochastic GCM emulations,mean T Mar,march,degrees Celsius,*degree*C*, +temperature_04,PALEO-PGEM-Series_monthly_temperature04_mean,Barreto2023,TRUE,PALEO-PGEM-Series_monthly_temperature04_mean.nc,https://figshare.com/ndownloader/files/42383658,,monthly_temperature04M,https://figshare.com/ndownloader/files/36426117,1.0.0,mean monthly temperature Apr over 10 stochastic GCM emulations,mean T Apr,april,degrees Celsius,*degree*C*, +temperature_05,PALEO-PGEM-Series_monthly_temperature05_mean,Barreto2023,TRUE,PALEO-PGEM-Series_monthly_temperature05_mean.nc,https://figshare.com/ndownloader/files/42383667,,monthly_temperature05M,https://figshare.com/ndownloader/files/36426117,1.0.0,mean monthly temperature May over 10 stochastic GCM emulations,mean T May,may,degrees Celsius,*degree*C*, +temperature_06,PALEO-PGEM-Series_monthly_temperature06_mean,Barreto2023,TRUE,PALEO-PGEM-Series_monthly_temperature06_mean.nc,https://figshare.com/ndownloader/files/42383664,,monthly_temperature06M,https://figshare.com/ndownloader/files/36426117,1.0.0,mean monthly temperature Jun over 10 stochastic GCM emulations,mean T Jun,june,degrees Celsius,*degree*C*, +temperature_07,PALEO-PGEM-Series_monthly_temperature07_mean,Barreto2023,TRUE,PALEO-PGEM-Series_monthly_temperature07_mean.nc,https://figshare.com/ndownloader/files/42383682,,monthly_temperature07M,https://figshare.com/ndownloader/files/36426117,1.0.0,mean monthly temperature Jul over 10 stochastic GCM emulations,mean T Jul,july,degrees Celsius,*degree*C*, +temperature_08,PALEO-PGEM-Series_monthly_temperature08_mean,Barreto2023,TRUE,PALEO-PGEM-Series_monthly_temperature08_mean.nc,https://figshare.com/ndownloader/files/42383670,,monthly_temperature08M,https://figshare.com/ndownloader/files/36426117,1.0.0,mean monthly temperature Aug over 10 stochastic GCM emulations,mean T Aug,august,degrees Celsius,*degree*C*, +temperature_09,PALEO-PGEM-Series_monthly_temperature09_mean,Barreto2023,TRUE,PALEO-PGEM-Series_monthly_temperature09_mean.nc,https://figshare.com/ndownloader/files/42383676,,monthly_temperature09M,https://figshare.com/ndownloader/files/36426117,1.0.0,mean monthly temperature Sep over 10 stochastic GCM emulations,mean T Sep,september,degrees Celsius,*degree*C*, +temperature_10,PALEO-PGEM-Series_monthly_temperature10_mean,Barreto2023,TRUE,PALEO-PGEM-Series_monthly_temperature10_mean.nc,https://figshare.com/ndownloader/files/42383685,,monthly_temperature10M,https://figshare.com/ndownloader/files/36426117,1.0.0,mean monthly temperature Oct over 10 stochastic GCM emulations,mean T Oct,october,degrees Celsius,*degree*C*, +temperature_11,PALEO-PGEM-Series_monthly_temperature11_mean,Barreto2023,TRUE,PALEO-PGEM-Series_monthly_temperature11_mean.nc,https://figshare.com/ndownloader/files/42383688,,monthly_temperature11M,https://figshare.com/ndownloader/files/36426117,1.0.0,mean monthly temperature Nov over 10 stochastic GCM emulations,mean T Nov,november,degrees Celsius,*degree*C*, +temperature_12,PALEO-PGEM-Series_monthly_temperature12_mean,Barreto2023,TRUE,PALEO-PGEM-Series_monthly_temperature12_mean.nc,https://figshare.com/ndownloader/files/42383691,,monthly_temperature12M,https://figshare.com/ndownloader/files/36426117,1.0.0,mean monthly temperature Dec over 10 stochastic GCM emulations,mean T Dec,december,degrees Celsius,*degree*C*, +precipitation_01,PALEO-PGEM-Series_monthly_precipitation01_mean,Barreto2023,TRUE,PALEO-PGEM-Series_monthly_precipitation01_mean.nc,https://figshare.com/ndownloader/files/42383697,,monthly_precipitation01M,https://figshare.com/ndownloader/files/36426117,1.0.0,mean monthly precipitation Jan over 10 stochastic GCM emulations,mean P Jan,january,mm per month,*mm~mo^-1*, +precipitation_02,PALEO-PGEM-Series_monthly_precipitation02_mean,Barreto2023,TRUE,PALEO-PGEM-Series_monthly_precipitation02_mean.nc,https://figshare.com/ndownloader/files/42383694,,monthly_precipitation02M,https://figshare.com/ndownloader/files/36426117,1.0.0,mean monthly precipitation Feb over 10 stochastic GCM emulations,mean P Feb,february,mm per month,*mm~mo^-1*, +precipitation_03,PALEO-PGEM-Series_monthly_precipitation03_mean,Barreto2023,TRUE,PALEO-PGEM-Series_monthly_precipitation03_mean.nc,https://figshare.com/ndownloader/files/42383700,,monthly_precipitation03M,https://figshare.com/ndownloader/files/36426117,1.0.0,mean monthly precipitation Mar over 10 stochastic GCM emulations,mean P Mar,march,mm per month,*mm~mo^-1*, +precipitation_04,PALEO-PGEM-Series_monthly_precipitation04_mean,Barreto2023,TRUE,PALEO-PGEM-Series_monthly_precipitation04_mean.nc,https://figshare.com/ndownloader/files/42383703,,monthly_precipitation04M,https://figshare.com/ndownloader/files/36426117,1.0.0,mean monthly precipitation Apr over 10 stochastic GCM emulations,mean P Apr,april,mm per month,*mm~mo^-1*, +precipitation_05,PALEO-PGEM-Series_monthly_precipitation05_mean,Barreto2023,TRUE,PALEO-PGEM-Series_monthly_precipitation05_mean.nc,https://figshare.com/ndownloader/files/42383706,,monthly_precipitation05M,https://figshare.com/ndownloader/files/36426117,1.0.0,mean monthly precipitation May over 10 stochastic GCM emulations,mean P May,may,mm per month,*mm~mo^-1*, +precipitation_06,PALEO-PGEM-Series_monthly_precipitation06_mean,Barreto2023,TRUE,PALEO-PGEM-Series_monthly_precipitation06_mean.nc,https://figshare.com/ndownloader/files/42383709,,monthly_precipitation06M,https://figshare.com/ndownloader/files/36426117,1.0.0,mean monthly precipitation Jun over 10 stochastic GCM emulations,mean P Jun,june,mm per month,*mm~mo^-1*, +precipitation_07,PALEO-PGEM-Series_monthly_precipitation07_mean,Barreto2023,TRUE,PALEO-PGEM-Series_monthly_precipitation07_mean.nc,https://figshare.com/ndownloader/files/42383712,,monthly_precipitation07M,https://figshare.com/ndownloader/files/36426117,1.0.0,mean monthly precipitation Jul over 10 stochastic GCM emulations,mean P Jul,july,mm per month,*mm~mo^-1*, +precipitation_08,PALEO-PGEM-Series_monthly_precipitation08_mean,Barreto2023,TRUE,PALEO-PGEM-Series_monthly_precipitation08_mean.nc,https://figshare.com/ndownloader/files/42383715,,monthly_precipitation08M,https://figshare.com/ndownloader/files/36426117,1.0.0,mean monthly precipitation Aug over 10 stochastic GCM emulations,mean P Aug,august,mm per month,*mm~mo^-1*, +precipitation_09,PALEO-PGEM-Series_monthly_precipitation09_mean,Barreto2023,TRUE,PALEO-PGEM-Series_monthly_precipitation09_mean.nc,https://figshare.com/ndownloader/files/42383727,,monthly_precipitation09M,https://figshare.com/ndownloader/files/36426117,1.0.0,mean monthly precipitation Sep over 10 stochastic GCM emulations,mean P Sep,september,mm per month,*mm~mo^-1*, +precipitation_10,PALEO-PGEM-Series_monthly_precipitation10_mean,Barreto2023,TRUE,PALEO-PGEM-Series_monthly_precipitation10_mean.nc,https://figshare.com/ndownloader/files/42383724,,monthly_precipitation10M,https://figshare.com/ndownloader/files/36426117,1.0.0,mean monthly precipitation Oct over 10 stochastic GCM emulations,mean P Oct,october,mm per month,*mm~mo^-1*, +precipitation_11,PALEO-PGEM-Series_monthly_precipitation11_mean,Barreto2023,TRUE,PALEO-PGEM-Series_monthly_precipitation11_mean.nc,https://figshare.com/ndownloader/files/42383721,,monthly_precipitation11M,https://figshare.com/ndownloader/files/36426117,1.0.0,mean monthly precipitation Nov over 10 stochastic GCM emulations,mean P Nov,november,mm per month,*mm~mo^-1*, +precipitation_12,PALEO-PGEM-Series_monthly_precipitation12_mean,Barreto2023,TRUE,PALEO-PGEM-Series_monthly_precipitation12_mean.nc,https://figshare.com/ndownloader/files/42383718,,monthly_precipitation12M,https://figshare.com/ndownloader/files/36426117,1.0.0,mean monthly precipitation Dec over 10 stochastic GCM emulations,mean P Dec,december,mm per month,*mm~mo^-1*, +temperature_sd_01,PALEO-PGEM-Series_monthly_temperature1_sd,Barreto2023,TRUE,PALEO-PGEM-Series_monthly_temperature1_sd.nc,https://figshare.com/ndownloader/files/42383949,,monthly_temperature1SD,https://figshare.com/ndownloader/files/38370173,1.0.0,standard deviation of the monthly temperature Jan over 10 stochastic GCM emulations,sd mean T Jan,january,degrees Celsius,*degree*C*, +temperature_sd_02,PALEO-PGEM-Series_monthly_temperature2_sd,Barreto2023,TRUE,PALEO-PGEM-Series_monthly_temperature2_sd.nc,https://figshare.com/ndownloader/files/42383943,,monthly_temperature2SD,https://figshare.com/ndownloader/files/38370173,1.0.0,standard deviation of the monthly temperature Feb over 10 stochastic GCM emulations,sd mean T Feb,february,degrees Celsius,*degree*C*, +temperature_sd_03,PALEO-PGEM-Series_monthly_temperature3_sd,Barreto2023,TRUE,PALEO-PGEM-Series_monthly_temperature3_sd.nc,https://figshare.com/ndownloader/files/42383946,,monthly_temperature3SD,https://figshare.com/ndownloader/files/38370173,1.0.0,standard deviation of the monthly temperature Mar over 10 stochastic GCM emulations,sd mean T Mar,march,degrees Celsius,*degree*C*, +temperature_sd_04,PALEO-PGEM-Series_monthly_temperature4_sd,Barreto2023,TRUE,PALEO-PGEM-Series_monthly_temperature4_sd.nc,https://figshare.com/ndownloader/files/42383937,,monthly_temperature4SD,https://figshare.com/ndownloader/files/38370173,1.0.0,standard deviation of the monthly temperature Apr over 10 stochastic GCM emulations,sd mean T Apr,april,degrees Celsius,*degree*C*, +temperature_sd_05,PALEO-PGEM-Series_monthly_temperature5_sd,Barreto2023,TRUE,PALEO-PGEM-Series_monthly_temperature5_sd.nc,https://figshare.com/ndownloader/files/42383928,,monthly_temperature5SD,https://figshare.com/ndownloader/files/38370173,1.0.0,standard deviation of the monthly temperature May over 10 stochastic GCM emulations,sd mean T May,may,degrees Celsius,*degree*C*, +temperature_sd_06,PALEO-PGEM-Series_monthly_temperature6_sd,Barreto2023,TRUE,PALEO-PGEM-Series_monthly_temperature6_sd.nc,https://figshare.com/ndownloader/files/42383940,,monthly_temperature6SD,https://figshare.com/ndownloader/files/38370173,1.0.0,standard deviation of the monthly temperature Jun over 10 stochastic GCM emulations,sd mean T Jun,june,degrees Celsius,*degree*C*, +temperature_sd_07,PALEO-PGEM-Series_monthly_temperature7_sd,Barreto2023,TRUE,PALEO-PGEM-Series_monthly_temperature7_sd.nc,https://figshare.com/ndownloader/files/42383931,,monthly_temperature7SD,https://figshare.com/ndownloader/files/38370173,1.0.0,standard deviation of the monthly temperature Jul over 10 stochastic GCM emulations,sd mean T Jul,july,degrees Celsius,*degree*C*, +temperature_sd_08,PALEO-PGEM-Series_monthly_temperature8_sd,Barreto2023,TRUE,PALEO-PGEM-Series_monthly_temperature8_sd.nc,https://figshare.com/ndownloader/files/42383934,,monthly_temperature8SD,https://figshare.com/ndownloader/files/38370173,1.0.0,standard deviation of the monthly temperature Aug over 10 stochastic GCM emulations,sd mean T Aug,august,degrees Celsius,*degree*C*, +temperature_sd_09,PALEO-PGEM-Series_monthly_temperature9_sd,Barreto2023,TRUE,PALEO-PGEM-Series_monthly_temperature9_sd.nc,https://figshare.com/ndownloader/files/42383952,,monthly_temperature9SD,https://figshare.com/ndownloader/files/38370173,1.0.0,standard deviation of the monthly temperature Sep over 10 stochastic GCM emulations,sd mean T Sep,september,degrees Celsius,*degree*C*, +temperature_sd_10,PALEO-PGEM-Series_monthly_temperature10_sd,Barreto2023,TRUE,PALEO-PGEM-Series_monthly_temperature10_sd.nc,https://figshare.com/ndownloader/files/42384126,,monthly_temperature10SD,https://figshare.com/ndownloader/files/38370173,1.0.0,standard deviation of the monthly temperature Oct over 10 stochastic GCM emulations,sd mean T Oct,october,degrees Celsius,*degree*C*, +temperature_sd_11,PALEO-PGEM-Series_monthly_temperature11_sd,Barreto2023,TRUE,PALEO-PGEM-Series_monthly_temperature11_sd.nc,https://figshare.com/ndownloader/files/42384150,,monthly_temperature11SD,https://figshare.com/ndownloader/files/38370173,1.0.0,standard deviation of the monthly temperature Nov over 10 stochastic GCM emulations,sd mean T Nov,november,degrees Celsius,*degree*C*, +temperature_sd_12,PALEO-PGEM-Series_monthly_temperature12_sd,Barreto2023,TRUE,PALEO-PGEM-Series_monthly_temperature12_sd.nc,https://figshare.com/ndownloader/files/42384153,,monthly_temperature12SD,https://figshare.com/ndownloader/files/38370173,1.0.0,standard deviation of the monthly temperature Dec over 10 stochastic GCM emulations,sd mean T Dec,december,degrees Celsius,*degree*C*, +precipitation_sd_01,PALEO-PGEM-Series_monthly_precipitation1_sd,Barreto2023,TRUE,PALEO-PGEM-Series_monthly_precipitation1_sd.nc,https://figshare.com/ndownloader/files/42383958,,monthly_precipitation1SD,https://figshare.com/ndownloader/files/38370173,1.0.0,standard deviation of the monthly precipitation Jan over 10 stochastic GCM emulations,sd P Jan,january,mm per month,*mm~mo^-1*, +precipitation_sd_02,PALEO-PGEM-Series_monthly_precipitation2_sd,Barreto2023,TRUE,PALEO-PGEM-Series_monthly_precipitation2_sd.nc,https://figshare.com/ndownloader/files/42383955,,monthly_precipitation2SD,https://figshare.com/ndownloader/files/38370173,1.0.0,standard deviation of the monthly precipitation Feb over 10 stochastic GCM emulations,sd P Feb,february,mm per month,*mm~mo^-1*, +precipitation_sd_03,PALEO-PGEM-Series_monthly_precipitation3_sd,Barreto2023,TRUE,PALEO-PGEM-Series_monthly_precipitation3_sd.nc,https://figshare.com/ndownloader/files/42383961,,monthly_precipitation3SD,https://figshare.com/ndownloader/files/38370173,1.0.0,standard deviation of the monthly precipitation Mar over 10 stochastic GCM emulations,sd P Mar,march,mm per month,*mm~mo^-1*, +precipitation_sd_04,PALEO-PGEM-Series_monthly_precipitation4_sd,Barreto2023,TRUE,PALEO-PGEM-Series_monthly_precipitation4_sd.nc,https://figshare.com/ndownloader/files/42383964,,monthly_precipitation4SD,https://figshare.com/ndownloader/files/38370173,1.0.0,standard deviation of the monthly precipitation Apr over 10 stochastic GCM emulations,sd P Apr,april,mm per month,*mm~mo^-1*, +precipitation_sd_05,PALEO-PGEM-Series_monthly_precipitation5_sd,Barreto2023,TRUE,PALEO-PGEM-Series_monthly_precipitation5_sd.nc,https://figshare.com/ndownloader/files/42383967,,monthly_precipitation5SD,https://figshare.com/ndownloader/files/38370173,1.0.0,standard deviation of the monthly precipitation May over 10 stochastic GCM emulations,sd P May,may,mm per month,*mm~mo^-1*, +precipitation_sd_06,PALEO-PGEM-Series_monthly_precipitation6_sd,Barreto2023,TRUE,PALEO-PGEM-Series_monthly_precipitation6_sd.nc,https://figshare.com/ndownloader/files/42383970,,monthly_precipitation6SD,https://figshare.com/ndownloader/files/38370173,1.0.0,standard deviation of the monthly precipitation Jun over 10 stochastic GCM emulations,sd P Jun,june,mm per month,*mm~mo^-1*, +precipitation_sd_07,PALEO-PGEM-Series_monthly_precipitation7_sd,Barreto2023,TRUE,PALEO-PGEM-Series_monthly_precipitation7_sd.nc,https://figshare.com/ndownloader/files/42383976,,monthly_precipitation7SD,https://figshare.com/ndownloader/files/38370173,1.0.0,standard deviation of the monthly precipitation Jul over 10 stochastic GCM emulations,sd P Jul,july,mm per month,*mm~mo^-1*, +precipitation_sd_08,PALEO-PGEM-Series_monthly_precipitation8_sd,Barreto2023,TRUE,PALEO-PGEM-Series_monthly_precipitation8_sd.nc,https://figshare.com/ndownloader/files/42383988,,monthly_precipitation8SD,https://figshare.com/ndownloader/files/38370173,1.0.0,standard deviation of the monthly precipitation Aug over 10 stochastic GCM emulations,sd P Aug,august,mm per month,*mm~mo^-1*, +precipitation_sd_09,PALEO-PGEM-Series_monthly_precipitation9_sd,Barreto2023,TRUE,PALEO-PGEM-Series_monthly_precipitation9_sd.nc,https://figshare.com/ndownloader/files/42383985,,monthly_precipitation9SD,https://figshare.com/ndownloader/files/38370173,1.0.0,standard deviation of the monthly precipitation Sep over 10 stochastic GCM emulations,sd P Sep,september,mm per month,*mm~mo^-1*, +precipitation_sd_10,PALEO-PGEM-Series_monthly_precipitation10_sd,Barreto2023,TRUE,PALEO-PGEM-Series_monthly_precipitation10_sd.nc,https://figshare.com/ndownloader/files/42383973,,monthly_precipitation10SD,https://figshare.com/ndownloader/files/38370173,1.0.0,standard deviation of the monthly precipitation Oct over 10 stochastic GCM emulations,sd P Oct,october,mm per month,*mm~mo^-1*, +precipitation_sd_11,PALEO-PGEM-Series_monthly_precipitation11_sd,Barreto2023,TRUE,PALEO-PGEM-Series_monthly_precipitation11_sd.nc,https://figshare.com/ndownloader/files/42383982,,monthly_precipitation11SD,https://figshare.com/ndownloader/files/38370173,1.0.0,standard deviation of the monthly precipitation Nov over 10 stochastic GCM emulations,sd P Nov,november,mm per month,*mm~mo^-1*, +precipitation_sd_12,PALEO-PGEM-Series_monthly_precipitation12_sd,Barreto2023,TRUE,PALEO-PGEM-Series_monthly_precipitation12_sd.nc,https://figshare.com/ndownloader/files/42383979,,monthly_precipitation12SD,https://figshare.com/ndownloader/files/38370173,1.0.0,standard deviation of the monthly precipitation Dec over 10 stochastic GCM emulations,sd P Dec,december,mm per month,*mm~mo^-1*, +bio01,bio01,WorldClim_2.1_10m,FALSE,WorldClim_2.1_10m_bio_v1.4.0.nc,,download_worldclim_present,,,1.4.0,annual mean temperature,ann. mean T,year,degrees Celsius,*degree*C*, +bio02,bio02,WorldClim_2.1_10m,FALSE,WorldClim_2.1_10m_bio_v1.4.0.nc,,download_worldclim_present,,,1.4.0,mean diurnal range,diurn. range,year,degrees Celsius,*degree*C*, +bio03,bio03,WorldClim_2.1_10m,FALSE,WorldClim_2.1_10m_bio_v1.4.0.nc,,download_worldclim_present,,,1.4.0,isothermality,isothermality,year,,, +bio04,bio04,WorldClim_2.1_10m,FALSE,WorldClim_2.1_10m_bio_v1.4.0.nc,,download_worldclim_present,,,1.4.0,temperature seasonality,T season.,year,degrees Celsius,*degree*C*, +bio05,bio05,WorldClim_2.1_10m,FALSE,WorldClim_2.1_10m_bio_v1.4.0.nc,,download_worldclim_present,,,1.4.0,maximum temperature of warmest month,max. T of warmest mo.,year,degrees Celsius,*degree*C*, +bio06,bio06,WorldClim_2.1_10m,FALSE,WorldClim_2.1_10m_bio_v1.4.0.nc,,download_worldclim_present,,,1.4.0,minimum temperature of coldest month,min. T of coldest mo.,year,degrees Celsius,*degree*C*, +bio07,bio07,WorldClim_2.1_10m,FALSE,WorldClim_2.1_10m_bio_v1.4.0.nc,,download_worldclim_present,,,1.4.0,temperature annual range (bio05-bio06),T ann. Range,year,degrees Celsius,*degree*C*, +bio08,bio08,WorldClim_2.1_10m,FALSE,WorldClim_2.1_10m_bio_v1.4.0.nc,,download_worldclim_present,,,1.4.0,mean temperature of wettest quarter,mean T of wettest qtr,year,degrees Celsius,*degree*C*, +bio09,bio09,WorldClim_2.1_10m,FALSE,WorldClim_2.1_10m_bio_v1.4.0.nc,,download_worldclim_present,,,1.4.0,mean temperature of driest quarter,mean T of driest qtr,year,degrees Celsius,*degree*C*, +bio10,bio10,WorldClim_2.1_10m,FALSE,WorldClim_2.1_10m_bio_v1.4.0.nc,,download_worldclim_present,,,1.4.0,mean temperature of warmest quarter,mean T of warmest qtr,year,degrees Celsius,*degree*C*, +bio11,bio11,WorldClim_2.1_10m,FALSE,WorldClim_2.1_10m_bio_v1.4.0.nc,,download_worldclim_present,,,1.4.0,mean temperature of coldest quarter,mean T of coldest qtr,year,degrees Celsius,*degree*C*, +bio12,bio12,WorldClim_2.1_10m,FALSE,WorldClim_2.1_10m_bio_v1.4.0.nc,,download_worldclim_present,,,1.4.0,annual precipitation,ann. P,year,mm per year,*mm~yr^-1*, +bio13,bio13,WorldClim_2.1_10m,FALSE,WorldClim_2.1_10m_bio_v1.4.0.nc,,download_worldclim_present,,,1.4.0,precipitation of wettest month,P of wettest mo.,year,mm per month,*mm~mo^-1*, +bio14,bio14,WorldClim_2.1_10m,FALSE,WorldClim_2.1_10m_bio_v1.4.0.nc,,download_worldclim_present,,,1.4.0,precipitation of driest month,P of driest mo.,year,mm per month,*mm~mo^-1*, +bio15,bio15,WorldClim_2.1_10m,FALSE,WorldClim_2.1_10m_bio_v1.4.0.nc,,download_worldclim_present,,,1.4.0,precipitation seasonality (coeff var),P season.,year,,, +bio16,bio16,WorldClim_2.1_10m,FALSE,WorldClim_2.1_10m_bio_v1.4.0.nc,,download_worldclim_present,,,1.4.0,precipitation of wettest quarter,P of wettest qtr,year,mm per quarter,*mm~qtr^-1*, +bio17,bio17,WorldClim_2.1_10m,FALSE,WorldClim_2.1_10m_bio_v1.4.0.nc,,download_worldclim_present,,,1.4.0,precipitation of driest quarter,P of driest qtr,year,mm per quarter,*mm~qtr^-1*, +bio18,bio18,WorldClim_2.1_10m,FALSE,WorldClim_2.1_10m_bio_v1.4.0.nc,,download_worldclim_present,,,1.4.0,precipitation of warmest quarter,P of warmest qtr,year,mm per quarter,*mm~qtr^-1*, +bio19,bio19,WorldClim_2.1_10m,FALSE,WorldClim_2.1_10m_bio_v1.4.0.nc,,download_worldclim_present,,,1.4.0,precipitation of coldest quarter,P of coldest qtr,year,mm per quarter,*mm~qtr^-1*, +altitude,altitude,WorldClim_2.1_10m,FALSE,WorldClim_2.1_10m_elev_v1.4.0.nc,,download_worldclim_present,,,1.4.0,altitude over the sea level,altitude,year,meters,*m*, +temperature_01,temperature_01,WorldClim_2.1_10m,TRUE,WorldClim_2.1_10m_tavg_v1.4.0.nc,,download_worldclim_present,,,1.4.0,mean temperature Jan,mean T Jan,january,degrees Celsius,*degree*C*, +temperature_02,temperature_02,WorldClim_2.1_10m,TRUE,WorldClim_2.1_10m_tavg_v1.4.0.nc,,download_worldclim_present,,,1.4.0,mean temperature Feb,mean T Feb,february,degrees Celsius,*degree*C*, +temperature_03,temperature_03,WorldClim_2.1_10m,TRUE,WorldClim_2.1_10m_tavg_v1.4.0.nc,,download_worldclim_present,,,1.4.0,mean temperature Mar,mean T Mar,march,degrees Celsius,*degree*C*, +temperature_04,temperature_04,WorldClim_2.1_10m,TRUE,WorldClim_2.1_10m_tavg_v1.4.0.nc,,download_worldclim_present,,,1.4.0,mean temperature Apr,mean T Apr,april,degrees Celsius,*degree*C*, +temperature_05,temperature_05,WorldClim_2.1_10m,TRUE,WorldClim_2.1_10m_tavg_v1.4.0.nc,,download_worldclim_present,,,1.4.0,mean temperature May,mean T May,may,degrees Celsius,*degree*C*, +temperature_06,temperature_06,WorldClim_2.1_10m,TRUE,WorldClim_2.1_10m_tavg_v1.4.0.nc,,download_worldclim_present,,,1.4.0,mean temperature Jun,mean T Jun,june,degrees Celsius,*degree*C*, +temperature_07,temperature_07,WorldClim_2.1_10m,TRUE,WorldClim_2.1_10m_tavg_v1.4.0.nc,,download_worldclim_present,,,1.4.0,mean temperature Jul,mean T Jul,july,degrees Celsius,*degree*C*, +temperature_08,temperature_08,WorldClim_2.1_10m,TRUE,WorldClim_2.1_10m_tavg_v1.4.0.nc,,download_worldclim_present,,,1.4.0,mean temperature Aug,mean T Aug,august,degrees Celsius,*degree*C*, +temperature_09,temperature_09,WorldClim_2.1_10m,TRUE,WorldClim_2.1_10m_tavg_v1.4.0.nc,,download_worldclim_present,,,1.4.0,mean temperature Sep,mean T Sep,september,degrees Celsius,*degree*C*, +temperature_10,temperature_10,WorldClim_2.1_10m,TRUE,WorldClim_2.1_10m_tavg_v1.4.0.nc,,download_worldclim_present,,,1.4.0,mean temperature Oct,mean T Oct,october,degrees Celsius,*degree*C*, +temperature_11,temperature_11,WorldClim_2.1_10m,TRUE,WorldClim_2.1_10m_tavg_v1.4.0.nc,,download_worldclim_present,,,1.4.0,mean temperature Nov,mean T Nov,november,degrees Celsius,*degree*C*, +temperature_12,temperature_12,WorldClim_2.1_10m,TRUE,WorldClim_2.1_10m_tavg_v1.4.0.nc,,download_worldclim_present,,,1.4.0,mean temperature Dec,mean T Dec,december,degrees Celsius,*degree*C*, +precipitation_01,precipitation_01,WorldClim_2.1_10m,TRUE,WorldClim_2.1_10m_prec_v1.4.0.nc,,download_worldclim_present,,,1.4.0,precipitation Jan,P Jan,january,mm per month,*mm~mo^-1*, +precipitation_02,precipitation_02,WorldClim_2.1_10m,TRUE,WorldClim_2.1_10m_prec_v1.4.0.nc,,download_worldclim_present,,,1.4.0,precipitation Feb,P Feb,february,mm per month,*mm~mo^-1*, +precipitation_03,precipitation_03,WorldClim_2.1_10m,TRUE,WorldClim_2.1_10m_prec_v1.4.0.nc,,download_worldclim_present,,,1.4.0,precipitation Mar,P Mar,march,mm per month,*mm~mo^-1*, +precipitation_04,precipitation_04,WorldClim_2.1_10m,TRUE,WorldClim_2.1_10m_prec_v1.4.0.nc,,download_worldclim_present,,,1.4.0,precipitation Apr,P Apr,april,mm per month,*mm~mo^-1*, +precipitation_05,precipitation_05,WorldClim_2.1_10m,TRUE,WorldClim_2.1_10m_prec_v1.4.0.nc,,download_worldclim_present,,,1.4.0,precipitation May,P May,may,mm per month,*mm~mo^-1*, +precipitation_06,precipitation_06,WorldClim_2.1_10m,TRUE,WorldClim_2.1_10m_prec_v1.4.0.nc,,download_worldclim_present,,,1.4.0,precipitation Jun,P Jun,june,mm per month,*mm~mo^-1*, +precipitation_07,precipitation_07,WorldClim_2.1_10m,TRUE,WorldClim_2.1_10m_prec_v1.4.0.nc,,download_worldclim_present,,,1.4.0,precipitation Jul,P Jul,july,mm per month,*mm~mo^-1*, +precipitation_08,precipitation_08,WorldClim_2.1_10m,TRUE,WorldClim_2.1_10m_prec_v1.4.0.nc,,download_worldclim_present,,,1.4.0,precipitation Aug,P Aug,august,mm per month,*mm~mo^-1*, +precipitation_09,precipitation_09,WorldClim_2.1_10m,TRUE,WorldClim_2.1_10m_prec_v1.4.0.nc,,download_worldclim_present,,,1.4.0,precipitation Sep,P Sep,september,mm per month,*mm~mo^-1*, +precipitation_10,precipitation_10,WorldClim_2.1_10m,TRUE,WorldClim_2.1_10m_prec_v1.4.0.nc,,download_worldclim_present,,,1.4.0,precipitation Oct,P Oct,october,mm per month,*mm~mo^-1*, +precipitation_11,precipitation_11,WorldClim_2.1_10m,TRUE,WorldClim_2.1_10m_prec_v1.4.0.nc,,download_worldclim_present,,,1.4.0,precipitation Nov,P Nov,november,mm per month,*mm~mo^-1*, +precipitation_12,precipitation_12,WorldClim_2.1_10m,TRUE,WorldClim_2.1_10m_prec_v1.4.0.nc,,download_worldclim_present,,,1.4.0,precipitation Dec,P Dec,december,mm per month,*mm~mo^-1*, +temperature_min_01,temperature_min_01,WorldClim_2.1_10m,TRUE,WorldClim_2.1_10m_tmin_v1.4.0.nc,,download_worldclim_present,,,1.4.0,minimum temperature Jan,min T Jan,january,degrees Celsius,*degree*C*, +temperature_min_02,temperature_min_02,WorldClim_2.1_10m,TRUE,WorldClim_2.1_10m_tmin_v1.4.0.nc,,download_worldclim_present,,,1.4.0,minimum temperature Feb,min T Feb,february,degrees Celsius,*degree*C*, +temperature_min_03,temperature_min_03,WorldClim_2.1_10m,TRUE,WorldClim_2.1_10m_tmin_v1.4.0.nc,,download_worldclim_present,,,1.4.0,minimum temperature Mar,min T Mar,march,degrees Celsius,*degree*C*, +temperature_min_04,temperature_min_04,WorldClim_2.1_10m,TRUE,WorldClim_2.1_10m_tmin_v1.4.0.nc,,download_worldclim_present,,,1.4.0,minimum temperature Apr,min T Apr,april,degrees Celsius,*degree*C*, +temperature_min_05,temperature_min_05,WorldClim_2.1_10m,TRUE,WorldClim_2.1_10m_tmin_v1.4.0.nc,,download_worldclim_present,,,1.4.0,minimum temperature May,min T May,may,degrees Celsius,*degree*C*, +temperature_min_06,temperature_min_06,WorldClim_2.1_10m,TRUE,WorldClim_2.1_10m_tmin_v1.4.0.nc,,download_worldclim_present,,,1.4.0,minimum temperature Jun,min T Jun,june,degrees Celsius,*degree*C*, +temperature_min_07,temperature_min_07,WorldClim_2.1_10m,TRUE,WorldClim_2.1_10m_tmin_v1.4.0.nc,,download_worldclim_present,,,1.4.0,minimum temperature Jul,min T Jul,july,degrees Celsius,*degree*C*, +temperature_min_08,temperature_min_08,WorldClim_2.1_10m,TRUE,WorldClim_2.1_10m_tmin_v1.4.0.nc,,download_worldclim_present,,,1.4.0,minimum temperature Aug,min T Aug,august,degrees Celsius,*degree*C*, +temperature_min_09,temperature_min_09,WorldClim_2.1_10m,TRUE,WorldClim_2.1_10m_tmin_v1.4.0.nc,,download_worldclim_present,,,1.4.0,minimum temperature Sep,min T Sep,september,degrees Celsius,*degree*C*, +temperature_min_10,temperature_min_10,WorldClim_2.1_10m,TRUE,WorldClim_2.1_10m_tmin_v1.4.0.nc,,download_worldclim_present,,,1.4.0,minimum temperature Oct,min T Oct,october,degrees Celsius,*degree*C*, +temperature_min_11,temperature_min_11,WorldClim_2.1_10m,TRUE,WorldClim_2.1_10m_tmin_v1.4.0.nc,,download_worldclim_present,,,1.4.0,minimum temperature Nov,min T Nov,november,degrees Celsius,*degree*C*, +temperature_min_12,temperature_min_12,WorldClim_2.1_10m,TRUE,WorldClim_2.1_10m_tmin_v1.4.0.nc,,download_worldclim_present,,,1.4.0,minimum temperature Dec,min T Dec,december,degrees Celsius,*degree*C*, +temperature_max_01,temperature_max_01,WorldClim_2.1_10m,TRUE,WorldClim_2.1_10m_tmax_v1.4.0.nc,,download_worldclim_present,,,1.4.0,maximum temperature Jan,max T Jan,january,degrees Celsius,*degree*C*, +temperature_max_02,temperature_max_02,WorldClim_2.1_10m,TRUE,WorldClim_2.1_10m_tmax_v1.4.0.nc,,download_worldclim_present,,,1.4.0,maximum temperature Feb,max T Feb,february,degrees Celsius,*degree*C*, +temperature_max_03,temperature_max_03,WorldClim_2.1_10m,TRUE,WorldClim_2.1_10m_tmax_v1.4.0.nc,,download_worldclim_present,,,1.4.0,maximum temperature Mar,max T Mar,march,degrees Celsius,*degree*C*, +temperature_max_04,temperature_max_04,WorldClim_2.1_10m,TRUE,WorldClim_2.1_10m_tmax_v1.4.0.nc,,download_worldclim_present,,,1.4.0,maximum temperature Apr,max T Apr,april,degrees Celsius,*degree*C*, +temperature_max_05,temperature_max_05,WorldClim_2.1_10m,TRUE,WorldClim_2.1_10m_tmax_v1.4.0.nc,,download_worldclim_present,,,1.4.0,maximum temperature May,max T May,may,degrees Celsius,*degree*C*, +temperature_max_06,temperature_max_06,WorldClim_2.1_10m,TRUE,WorldClim_2.1_10m_tmax_v1.4.0.nc,,download_worldclim_present,,,1.4.0,maximum temperature Jun,max T Jun,june,degrees Celsius,*degree*C*, +temperature_max_07,temperature_max_07,WorldClim_2.1_10m,TRUE,WorldClim_2.1_10m_tmax_v1.4.0.nc,,download_worldclim_present,,,1.4.0,maximum temperature Jul,max T Jul,july,degrees Celsius,*degree*C*, +temperature_max_08,temperature_max_08,WorldClim_2.1_10m,TRUE,WorldClim_2.1_10m_tmax_v1.4.0.nc,,download_worldclim_present,,,1.4.0,maximum temperature Aug,max T Aug,august,degrees Celsius,*degree*C*, +temperature_max_09,temperature_max_09,WorldClim_2.1_10m,TRUE,WorldClim_2.1_10m_tmax_v1.4.0.nc,,download_worldclim_present,,,1.4.0,maximum temperature Sep,max T Sep,september,degrees Celsius,*degree*C*, +temperature_max_10,temperature_max_10,WorldClim_2.1_10m,TRUE,WorldClim_2.1_10m_tmax_v1.4.0.nc,,download_worldclim_present,,,1.4.0,maximum temperature Oct,max T Oct,october,degrees Celsius,*degree*C*, +temperature_max_11,temperature_max_11,WorldClim_2.1_10m,TRUE,WorldClim_2.1_10m_tmax_v1.4.0.nc,,download_worldclim_present,,,1.4.0,maximum temperature Nov,max T Nov,november,degrees Celsius,*degree*C*, +temperature_max_12,temperature_max_12,WorldClim_2.1_10m,TRUE,WorldClim_2.1_10m_tmax_v1.4.0.nc,,download_worldclim_present,,,1.4.0,maximum temperature Dec,max T Dec,december,degrees Celsius,*degree*C*, +bio01,bio01,WorldClim_2.1_5m,FALSE,WorldClim_2.1_5m_bio_v1.4.0.nc,,download_worldclim_present,,,1.4.0,annual mean temperature,ann. mean T,year,degrees Celsius,*degree*C*, +bio02,bio02,WorldClim_2.1_5m,FALSE,WorldClim_2.1_5m_bio_v1.4.0.nc,,download_worldclim_present,,,1.4.0,mean diurnal range,diurn. range,year,degrees Celsius,*degree*C*, +bio03,bio03,WorldClim_2.1_5m,FALSE,WorldClim_2.1_5m_bio_v1.4.0.nc,,download_worldclim_present,,,1.4.0,isothermality,isothermality,year,,, +bio04,bio04,WorldClim_2.1_5m,FALSE,WorldClim_2.1_5m_bio_v1.4.0.nc,,download_worldclim_present,,,1.4.0,temperature seasonality,T season.,year,degrees Celsius,*degree*C*, +bio05,bio05,WorldClim_2.1_5m,FALSE,WorldClim_2.1_5m_bio_v1.4.0.nc,,download_worldclim_present,,,1.4.0,maximum temperature of warmest month,max. T of warmest mo.,year,degrees Celsius,*degree*C*, +bio06,bio06,WorldClim_2.1_5m,FALSE,WorldClim_2.1_5m_bio_v1.4.0.nc,,download_worldclim_present,,,1.4.0,minimum temperature of coldest month,min. T of coldest mo.,year,degrees Celsius,*degree*C*, +bio07,bio07,WorldClim_2.1_5m,FALSE,WorldClim_2.1_5m_bio_v1.4.0.nc,,download_worldclim_present,,,1.4.0,temperature annual range (bio05-bio06),T ann. Range,year,degrees Celsius,*degree*C*, +bio08,bio08,WorldClim_2.1_5m,FALSE,WorldClim_2.1_5m_bio_v1.4.0.nc,,download_worldclim_present,,,1.4.0,mean temperature of wettest quarter,mean T of wettest qtr,year,degrees Celsius,*degree*C*, +bio09,bio09,WorldClim_2.1_5m,FALSE,WorldClim_2.1_5m_bio_v1.4.0.nc,,download_worldclim_present,,,1.4.0,mean temperature of driest quarter,mean T of driest qtr,year,degrees Celsius,*degree*C*, +bio10,bio10,WorldClim_2.1_5m,FALSE,WorldClim_2.1_5m_bio_v1.4.0.nc,,download_worldclim_present,,,1.4.0,mean temperature of warmest quarter,mean T of warmest qtr,year,degrees Celsius,*degree*C*, +bio11,bio11,WorldClim_2.1_5m,FALSE,WorldClim_2.1_5m_bio_v1.4.0.nc,,download_worldclim_present,,,1.4.0,mean temperature of coldest quarter,mean T of coldest qtr,year,degrees Celsius,*degree*C*, +bio12,bio12,WorldClim_2.1_5m,FALSE,WorldClim_2.1_5m_bio_v1.4.0.nc,,download_worldclim_present,,,1.4.0,annual precipitation,ann. P,year,mm per year,*mm~yr^-1*, +bio13,bio13,WorldClim_2.1_5m,FALSE,WorldClim_2.1_5m_bio_v1.4.0.nc,,download_worldclim_present,,,1.4.0,precipitation of wettest month,P of wettest mo.,year,mm per month,*mm~mo^-1*, +bio14,bio14,WorldClim_2.1_5m,FALSE,WorldClim_2.1_5m_bio_v1.4.0.nc,,download_worldclim_present,,,1.4.0,precipitation of driest month,P of driest mo.,year,mm per month,*mm~mo^-1*, +bio15,bio15,WorldClim_2.1_5m,FALSE,WorldClim_2.1_5m_bio_v1.4.0.nc,,download_worldclim_present,,,1.4.0,precipitation seasonality (coeff var),P season.,year,,, +bio16,bio16,WorldClim_2.1_5m,FALSE,WorldClim_2.1_5m_bio_v1.4.0.nc,,download_worldclim_present,,,1.4.0,precipitation of wettest quarter,P of wettest qtr,year,mm per quarter,*mm~qtr^-1*, +bio17,bio17,WorldClim_2.1_5m,FALSE,WorldClim_2.1_5m_bio_v1.4.0.nc,,download_worldclim_present,,,1.4.0,precipitation of driest quarter,P of driest qtr,year,mm per quarter,*mm~qtr^-1*, +bio18,bio18,WorldClim_2.1_5m,FALSE,WorldClim_2.1_5m_bio_v1.4.0.nc,,download_worldclim_present,,,1.4.0,precipitation of warmest quarter,P of warmest qtr,year,mm per quarter,*mm~qtr^-1*, +bio19,bio19,WorldClim_2.1_5m,FALSE,WorldClim_2.1_5m_bio_v1.4.0.nc,,download_worldclim_present,,,1.4.0,precipitation of coldest quarter,P of coldest qtr,year,mm per quarter,*mm~qtr^-1*, +altitude,altitude,WorldClim_2.1_5m,FALSE,WorldClim_2.1_5m_elev_v1.4.0.nc,,download_worldclim_present,,,1.4.0,altitude over the sea level,altitude,year,meters,*m*, +temperature_01,temperature_01,WorldClim_2.1_5m,TRUE,WorldClim_2.1_5m_tavg_v1.4.0.nc,,download_worldclim_present,,,1.4.0,mean temperature Jan,mean T Jan,january,degrees Celsius,*degree*C*, +temperature_02,temperature_02,WorldClim_2.1_5m,TRUE,WorldClim_2.1_5m_tavg_v1.4.0.nc,,download_worldclim_present,,,1.4.0,mean temperature Feb,mean T Feb,february,degrees Celsius,*degree*C*, +temperature_03,temperature_03,WorldClim_2.1_5m,TRUE,WorldClim_2.1_5m_tavg_v1.4.0.nc,,download_worldclim_present,,,1.4.0,mean temperature Mar,mean T Mar,march,degrees Celsius,*degree*C*, +temperature_04,temperature_04,WorldClim_2.1_5m,TRUE,WorldClim_2.1_5m_tavg_v1.4.0.nc,,download_worldclim_present,,,1.4.0,mean temperature Apr,mean T Apr,april,degrees Celsius,*degree*C*, +temperature_05,temperature_05,WorldClim_2.1_5m,TRUE,WorldClim_2.1_5m_tavg_v1.4.0.nc,,download_worldclim_present,,,1.4.0,mean temperature May,mean T May,may,degrees Celsius,*degree*C*, +temperature_06,temperature_06,WorldClim_2.1_5m,TRUE,WorldClim_2.1_5m_tavg_v1.4.0.nc,,download_worldclim_present,,,1.4.0,mean temperature Jun,mean T Jun,june,degrees Celsius,*degree*C*, +temperature_07,temperature_07,WorldClim_2.1_5m,TRUE,WorldClim_2.1_5m_tavg_v1.4.0.nc,,download_worldclim_present,,,1.4.0,mean temperature Jul,mean T Jul,july,degrees Celsius,*degree*C*, +temperature_08,temperature_08,WorldClim_2.1_5m,TRUE,WorldClim_2.1_5m_tavg_v1.4.0.nc,,download_worldclim_present,,,1.4.0,mean temperature Aug,mean T Aug,august,degrees Celsius,*degree*C*, +temperature_09,temperature_09,WorldClim_2.1_5m,TRUE,WorldClim_2.1_5m_tavg_v1.4.0.nc,,download_worldclim_present,,,1.4.0,mean temperature Sep,mean T Sep,september,degrees Celsius,*degree*C*, +temperature_10,temperature_10,WorldClim_2.1_5m,TRUE,WorldClim_2.1_5m_tavg_v1.4.0.nc,,download_worldclim_present,,,1.4.0,mean temperature Oct,mean T Oct,october,degrees Celsius,*degree*C*, +temperature_11,temperature_11,WorldClim_2.1_5m,TRUE,WorldClim_2.1_5m_tavg_v1.4.0.nc,,download_worldclim_present,,,1.4.0,mean temperature Nov,mean T Nov,november,degrees Celsius,*degree*C*, +temperature_12,temperature_12,WorldClim_2.1_5m,TRUE,WorldClim_2.1_5m_tavg_v1.4.0.nc,,download_worldclim_present,,,1.4.0,mean temperature Dec,mean T Dec,december,degrees Celsius,*degree*C*, +precipitation_01,precipitation_01,WorldClim_2.1_5m,TRUE,WorldClim_2.1_5m_prec_v1.4.0.nc,,download_worldclim_present,,,1.4.0,precipitation Jan,P Jan,january,mm per month,*mm~mo^-1*, +precipitation_02,precipitation_02,WorldClim_2.1_5m,TRUE,WorldClim_2.1_5m_prec_v1.4.0.nc,,download_worldclim_present,,,1.4.0,precipitation Feb,P Feb,february,mm per month,*mm~mo^-1*, +precipitation_03,precipitation_03,WorldClim_2.1_5m,TRUE,WorldClim_2.1_5m_prec_v1.4.0.nc,,download_worldclim_present,,,1.4.0,precipitation Mar,P Mar,march,mm per month,*mm~mo^-1*, +precipitation_04,precipitation_04,WorldClim_2.1_5m,TRUE,WorldClim_2.1_5m_prec_v1.4.0.nc,,download_worldclim_present,,,1.4.0,precipitation Apr,P Apr,april,mm per month,*mm~mo^-1*, +precipitation_05,precipitation_05,WorldClim_2.1_5m,TRUE,WorldClim_2.1_5m_prec_v1.4.0.nc,,download_worldclim_present,,,1.4.0,precipitation May,P May,may,mm per month,*mm~mo^-1*, +precipitation_06,precipitation_06,WorldClim_2.1_5m,TRUE,WorldClim_2.1_5m_prec_v1.4.0.nc,,download_worldclim_present,,,1.4.0,precipitation Jun,P Jun,june,mm per month,*mm~mo^-1*, +precipitation_07,precipitation_07,WorldClim_2.1_5m,TRUE,WorldClim_2.1_5m_prec_v1.4.0.nc,,download_worldclim_present,,,1.4.0,precipitation Jul,P Jul,july,mm per month,*mm~mo^-1*, +precipitation_08,precipitation_08,WorldClim_2.1_5m,TRUE,WorldClim_2.1_5m_prec_v1.4.0.nc,,download_worldclim_present,,,1.4.0,precipitation Aug,P Aug,august,mm per month,*mm~mo^-1*, +precipitation_09,precipitation_09,WorldClim_2.1_5m,TRUE,WorldClim_2.1_5m_prec_v1.4.0.nc,,download_worldclim_present,,,1.4.0,precipitation Sep,P Sep,september,mm per month,*mm~mo^-1*, +precipitation_10,precipitation_10,WorldClim_2.1_5m,TRUE,WorldClim_2.1_5m_prec_v1.4.0.nc,,download_worldclim_present,,,1.4.0,precipitation Oct,P Oct,october,mm per month,*mm~mo^-1*, +precipitation_11,precipitation_11,WorldClim_2.1_5m,TRUE,WorldClim_2.1_5m_prec_v1.4.0.nc,,download_worldclim_present,,,1.4.0,precipitation Nov,P Nov,november,mm per month,*mm~mo^-1*, +precipitation_12,precipitation_12,WorldClim_2.1_5m,TRUE,WorldClim_2.1_5m_prec_v1.4.0.nc,,download_worldclim_present,,,1.4.0,precipitation Dec,P Dec,december,mm per month,*mm~mo^-1*, +temperature_min_01,temperature_min_01,WorldClim_2.1_5m,TRUE,WorldClim_2.1_5m_tmin_v1.4.0.nc,,download_worldclim_present,,,1.4.0,minimum temperature Jan,min T Jan,january,degrees Celsius,*degree*C*, +temperature_min_02,temperature_min_02,WorldClim_2.1_5m,TRUE,WorldClim_2.1_5m_tmin_v1.4.0.nc,,download_worldclim_present,,,1.4.0,minimum temperature Feb,min T Feb,february,degrees Celsius,*degree*C*, +temperature_min_03,temperature_min_03,WorldClim_2.1_5m,TRUE,WorldClim_2.1_5m_tmin_v1.4.0.nc,,download_worldclim_present,,,1.4.0,minimum temperature Mar,min T Mar,march,degrees Celsius,*degree*C*, +temperature_min_04,temperature_min_04,WorldClim_2.1_5m,TRUE,WorldClim_2.1_5m_tmin_v1.4.0.nc,,download_worldclim_present,,,1.4.0,minimum temperature Apr,min T Apr,april,degrees Celsius,*degree*C*, +temperature_min_05,temperature_min_05,WorldClim_2.1_5m,TRUE,WorldClim_2.1_5m_tmin_v1.4.0.nc,,download_worldclim_present,,,1.4.0,minimum temperature May,min T May,may,degrees Celsius,*degree*C*, +temperature_min_06,temperature_min_06,WorldClim_2.1_5m,TRUE,WorldClim_2.1_5m_tmin_v1.4.0.nc,,download_worldclim_present,,,1.4.0,minimum temperature Jun,min T Jun,june,degrees Celsius,*degree*C*, +temperature_min_07,temperature_min_07,WorldClim_2.1_5m,TRUE,WorldClim_2.1_5m_tmin_v1.4.0.nc,,download_worldclim_present,,,1.4.0,minimum temperature Jul,min T Jul,july,degrees Celsius,*degree*C*, +temperature_min_08,temperature_min_08,WorldClim_2.1_5m,TRUE,WorldClim_2.1_5m_tmin_v1.4.0.nc,,download_worldclim_present,,,1.4.0,minimum temperature Aug,min T Aug,august,degrees Celsius,*degree*C*, +temperature_min_09,temperature_min_09,WorldClim_2.1_5m,TRUE,WorldClim_2.1_5m_tmin_v1.4.0.nc,,download_worldclim_present,,,1.4.0,minimum temperature Sep,min T Sep,september,degrees Celsius,*degree*C*, +temperature_min_10,temperature_min_10,WorldClim_2.1_5m,TRUE,WorldClim_2.1_5m_tmin_v1.4.0.nc,,download_worldclim_present,,,1.4.0,minimum temperature Oct,min T Oct,october,degrees Celsius,*degree*C*, +temperature_min_11,temperature_min_11,WorldClim_2.1_5m,TRUE,WorldClim_2.1_5m_tmin_v1.4.0.nc,,download_worldclim_present,,,1.4.0,minimum temperature Nov,min T Nov,november,degrees Celsius,*degree*C*, +temperature_min_12,temperature_min_12,WorldClim_2.1_5m,TRUE,WorldClim_2.1_5m_tmin_v1.4.0.nc,,download_worldclim_present,,,1.4.0,minimum temperature Dec,min T Dec,december,degrees Celsius,*degree*C*, +temperature_max_01,temperature_max_01,WorldClim_2.1_5m,TRUE,WorldClim_2.1_5m_tmax_v1.4.0.nc,,download_worldclim_present,,,1.4.0,maximum temperature Jan,max T Jan,january,degrees Celsius,*degree*C*, +temperature_max_02,temperature_max_02,WorldClim_2.1_5m,TRUE,WorldClim_2.1_5m_tmax_v1.4.0.nc,,download_worldclim_present,,,1.4.0,maximum temperature Feb,max T Feb,february,degrees Celsius,*degree*C*, +temperature_max_03,temperature_max_03,WorldClim_2.1_5m,TRUE,WorldClim_2.1_5m_tmax_v1.4.0.nc,,download_worldclim_present,,,1.4.0,maximum temperature Mar,max T Mar,march,degrees Celsius,*degree*C*, +temperature_max_04,temperature_max_04,WorldClim_2.1_5m,TRUE,WorldClim_2.1_5m_tmax_v1.4.0.nc,,download_worldclim_present,,,1.4.0,maximum temperature Apr,max T Apr,april,degrees Celsius,*degree*C*, +temperature_max_05,temperature_max_05,WorldClim_2.1_5m,TRUE,WorldClim_2.1_5m_tmax_v1.4.0.nc,,download_worldclim_present,,,1.4.0,maximum temperature May,max T May,may,degrees Celsius,*degree*C*, +temperature_max_06,temperature_max_06,WorldClim_2.1_5m,TRUE,WorldClim_2.1_5m_tmax_v1.4.0.nc,,download_worldclim_present,,,1.4.0,maximum temperature Jun,max T Jun,june,degrees Celsius,*degree*C*, +temperature_max_07,temperature_max_07,WorldClim_2.1_5m,TRUE,WorldClim_2.1_5m_tmax_v1.4.0.nc,,download_worldclim_present,,,1.4.0,maximum temperature Jul,max T Jul,july,degrees Celsius,*degree*C*, +temperature_max_08,temperature_max_08,WorldClim_2.1_5m,TRUE,WorldClim_2.1_5m_tmax_v1.4.0.nc,,download_worldclim_present,,,1.4.0,maximum temperature Aug,max T Aug,august,degrees Celsius,*degree*C*, +temperature_max_09,temperature_max_09,WorldClim_2.1_5m,TRUE,WorldClim_2.1_5m_tmax_v1.4.0.nc,,download_worldclim_present,,,1.4.0,maximum temperature Sep,max T Sep,september,degrees Celsius,*degree*C*, +temperature_max_10,temperature_max_10,WorldClim_2.1_5m,TRUE,WorldClim_2.1_5m_tmax_v1.4.0.nc,,download_worldclim_present,,,1.4.0,maximum temperature Oct,max T Oct,october,degrees Celsius,*degree*C*, +temperature_max_11,temperature_max_11,WorldClim_2.1_5m,TRUE,WorldClim_2.1_5m_tmax_v1.4.0.nc,,download_worldclim_present,,,1.4.0,maximum temperature Nov,max T Nov,november,degrees Celsius,*degree*C*, +temperature_max_12,temperature_max_12,WorldClim_2.1_5m,TRUE,WorldClim_2.1_5m_tmax_v1.4.0.nc,,download_worldclim_present,,,1.4.0,maximum temperature Dec,max T Dec,december,degrees Celsius,*degree*C*, +bio01,bio01,WorldClim_2.1_ACCESS-CM2_ssp126_10m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual mean temperature,ann. mean T,year,degrees Celsius,*degree*C*, +bio02,bio02,WorldClim_2.1_ACCESS-CM2_ssp126_10m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean diurnal range,diurn. range,year,degrees Celsius,*degree*C*, +bio03,bio03,WorldClim_2.1_ACCESS-CM2_ssp126_10m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,isothermality,isothermality,year,,, +bio04,bio04,WorldClim_2.1_ACCESS-CM2_ssp126_10m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature seasonality,T season.,year,degrees Celsius,*degree*C*, +bio05,bio05,WorldClim_2.1_ACCESS-CM2_ssp126_10m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature of warmest month,max. T of warmest mo.,year,degrees Celsius,*degree*C*, +bio06,bio06,WorldClim_2.1_ACCESS-CM2_ssp126_10m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature of coldest month,min. T of coldest mo.,year,degrees Celsius,*degree*C*, +bio07,bio07,WorldClim_2.1_ACCESS-CM2_ssp126_10m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature annual range (bio05-bio06),T ann. Range,year,degrees Celsius,*degree*C*, +bio08,bio08,WorldClim_2.1_ACCESS-CM2_ssp126_10m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of wettest quarter,mean T of wettest qtr,year,degrees Celsius,*degree*C*, +bio09,bio09,WorldClim_2.1_ACCESS-CM2_ssp126_10m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of driest quarter,mean T of driest qtr,year,degrees Celsius,*degree*C*, +bio10,bio10,WorldClim_2.1_ACCESS-CM2_ssp126_10m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of warmest quarter,mean T of warmest qtr,year,degrees Celsius,*degree*C*, +bio11,bio11,WorldClim_2.1_ACCESS-CM2_ssp126_10m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of coldest quarter,mean T of coldest qtr,year,degrees Celsius,*degree*C*, +bio12,bio12,WorldClim_2.1_ACCESS-CM2_ssp126_10m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual precipitation,ann. P,year,mm per year,*mm~yr^-1*, +bio13,bio13,WorldClim_2.1_ACCESS-CM2_ssp126_10m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest month,P of wettest mo.,year,mm per month,*mm~mo^-1*, +bio14,bio14,WorldClim_2.1_ACCESS-CM2_ssp126_10m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest month,P of driest mo.,year,mm per month,*mm~mo^-1*, +bio15,bio15,WorldClim_2.1_ACCESS-CM2_ssp126_10m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation seasonality (coeff var),P season.,year,,, +bio16,bio16,WorldClim_2.1_ACCESS-CM2_ssp126_10m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest quarter,P of wettest qtr,year,mm per quarter,*mm~qtr^-1*, +bio17,bio17,WorldClim_2.1_ACCESS-CM2_ssp126_10m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest quarter,P of driest qtr,year,mm per quarter,*mm~qtr^-1*, +bio18,bio18,WorldClim_2.1_ACCESS-CM2_ssp126_10m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of warmest quarter,P of warmest qtr,year,mm per quarter,*mm~qtr^-1*, +bio19,bio19,WorldClim_2.1_ACCESS-CM2_ssp126_10m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of coldest quarter,P of coldest qtr,year,mm per quarter,*mm~qtr^-1*, +precipitation_01,precipitation_01,WorldClim_2.1_ACCESS-CM2_ssp126_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jan,P Jan,january,mm per month,*mm~mo^-1*, +precipitation_02,precipitation_02,WorldClim_2.1_ACCESS-CM2_ssp126_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Feb,P Feb,february,mm per month,*mm~mo^-1*, +precipitation_03,precipitation_03,WorldClim_2.1_ACCESS-CM2_ssp126_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Mar,P Mar,march,mm per month,*mm~mo^-1*, +precipitation_04,precipitation_04,WorldClim_2.1_ACCESS-CM2_ssp126_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Apr,P Apr,april,mm per month,*mm~mo^-1*, +precipitation_05,precipitation_05,WorldClim_2.1_ACCESS-CM2_ssp126_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation May,P May,may,mm per month,*mm~mo^-1*, +precipitation_06,precipitation_06,WorldClim_2.1_ACCESS-CM2_ssp126_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jun,P Jun,june,mm per month,*mm~mo^-1*, +precipitation_07,precipitation_07,WorldClim_2.1_ACCESS-CM2_ssp126_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jul,P Jul,july,mm per month,*mm~mo^-1*, +precipitation_08,precipitation_08,WorldClim_2.1_ACCESS-CM2_ssp126_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Aug,P Aug,august,mm per month,*mm~mo^-1*, +precipitation_09,precipitation_09,WorldClim_2.1_ACCESS-CM2_ssp126_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Sep,P Sep,september,mm per month,*mm~mo^-1*, +precipitation_10,precipitation_10,WorldClim_2.1_ACCESS-CM2_ssp126_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Oct,P Oct,october,mm per month,*mm~mo^-1*, +precipitation_11,precipitation_11,WorldClim_2.1_ACCESS-CM2_ssp126_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Nov,P Nov,november,mm per month,*mm~mo^-1*, +precipitation_12,precipitation_12,WorldClim_2.1_ACCESS-CM2_ssp126_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Dec,P Dec,december,mm per month,*mm~mo^-1*, +temperature_min_01,temperature_min_01,WorldClim_2.1_ACCESS-CM2_ssp126_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jan,min T Jan,january,degrees Celsius,*degree*C*, +temperature_min_02,temperature_min_02,WorldClim_2.1_ACCESS-CM2_ssp126_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Feb,min T Feb,february,degrees Celsius,*degree*C*, +temperature_min_03,temperature_min_03,WorldClim_2.1_ACCESS-CM2_ssp126_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Mar,min T Mar,march,degrees Celsius,*degree*C*, +temperature_min_04,temperature_min_04,WorldClim_2.1_ACCESS-CM2_ssp126_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Apr,min T Apr,april,degrees Celsius,*degree*C*, +temperature_min_05,temperature_min_05,WorldClim_2.1_ACCESS-CM2_ssp126_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature May,min T May,may,degrees Celsius,*degree*C*, +temperature_min_06,temperature_min_06,WorldClim_2.1_ACCESS-CM2_ssp126_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jun,min T Jun,june,degrees Celsius,*degree*C*, +temperature_min_07,temperature_min_07,WorldClim_2.1_ACCESS-CM2_ssp126_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jul,min T Jul,july,degrees Celsius,*degree*C*, +temperature_min_08,temperature_min_08,WorldClim_2.1_ACCESS-CM2_ssp126_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Aug,min T Aug,august,degrees Celsius,*degree*C*, +temperature_min_09,temperature_min_09,WorldClim_2.1_ACCESS-CM2_ssp126_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Sep,min T Sep,september,degrees Celsius,*degree*C*, +temperature_min_10,temperature_min_10,WorldClim_2.1_ACCESS-CM2_ssp126_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Oct,min T Oct,october,degrees Celsius,*degree*C*, +temperature_min_11,temperature_min_11,WorldClim_2.1_ACCESS-CM2_ssp126_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Nov,min T Nov,november,degrees Celsius,*degree*C*, +temperature_min_12,temperature_min_12,WorldClim_2.1_ACCESS-CM2_ssp126_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Dec,min T Dec,december,degrees Celsius,*degree*C*, +temperature_max_01,temperature_max_01,WorldClim_2.1_ACCESS-CM2_ssp126_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jan,max T Jan,january,degrees Celsius,*degree*C*, +temperature_max_02,temperature_max_02,WorldClim_2.1_ACCESS-CM2_ssp126_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Feb,max T Feb,february,degrees Celsius,*degree*C*, +temperature_max_03,temperature_max_03,WorldClim_2.1_ACCESS-CM2_ssp126_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Mar,max T Mar,march,degrees Celsius,*degree*C*, +temperature_max_04,temperature_max_04,WorldClim_2.1_ACCESS-CM2_ssp126_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Apr,max T Apr,april,degrees Celsius,*degree*C*, +temperature_max_05,temperature_max_05,WorldClim_2.1_ACCESS-CM2_ssp126_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature May,max T May,may,degrees Celsius,*degree*C*, +temperature_max_06,temperature_max_06,WorldClim_2.1_ACCESS-CM2_ssp126_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jun,max T Jun,june,degrees Celsius,*degree*C*, +temperature_max_07,temperature_max_07,WorldClim_2.1_ACCESS-CM2_ssp126_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jul,max T Jul,july,degrees Celsius,*degree*C*, +temperature_max_08,temperature_max_08,WorldClim_2.1_ACCESS-CM2_ssp126_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Aug,max T Aug,august,degrees Celsius,*degree*C*, +temperature_max_09,temperature_max_09,WorldClim_2.1_ACCESS-CM2_ssp126_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Sep,max T Sep,september,degrees Celsius,*degree*C*, +temperature_max_10,temperature_max_10,WorldClim_2.1_ACCESS-CM2_ssp126_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Oct,max T Oct,october,degrees Celsius,*degree*C*, +temperature_max_11,temperature_max_11,WorldClim_2.1_ACCESS-CM2_ssp126_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Nov,max T Nov,november,degrees Celsius,*degree*C*, +temperature_max_12,temperature_max_12,WorldClim_2.1_ACCESS-CM2_ssp126_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Dec,max T Dec,december,degrees Celsius,*degree*C*, +bio01,bio01,WorldClim_2.1_ACCESS-CM2_ssp126_5m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual mean temperature,ann. mean T,year,degrees Celsius,*degree*C*, +bio02,bio02,WorldClim_2.1_ACCESS-CM2_ssp126_5m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean diurnal range,diurn. range,year,degrees Celsius,*degree*C*, +bio03,bio03,WorldClim_2.1_ACCESS-CM2_ssp126_5m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,isothermality,isothermality,year,,, +bio04,bio04,WorldClim_2.1_ACCESS-CM2_ssp126_5m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature seasonality,T season.,year,degrees Celsius,*degree*C*, +bio05,bio05,WorldClim_2.1_ACCESS-CM2_ssp126_5m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature of warmest month,max. T of warmest mo.,year,degrees Celsius,*degree*C*, +bio06,bio06,WorldClim_2.1_ACCESS-CM2_ssp126_5m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature of coldest month,min. T of coldest mo.,year,degrees Celsius,*degree*C*, +bio07,bio07,WorldClim_2.1_ACCESS-CM2_ssp126_5m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature annual range (bio05-bio06),T ann. Range,year,degrees Celsius,*degree*C*, +bio08,bio08,WorldClim_2.1_ACCESS-CM2_ssp126_5m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of wettest quarter,mean T of wettest qtr,year,degrees Celsius,*degree*C*, +bio09,bio09,WorldClim_2.1_ACCESS-CM2_ssp126_5m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of driest quarter,mean T of driest qtr,year,degrees Celsius,*degree*C*, +bio10,bio10,WorldClim_2.1_ACCESS-CM2_ssp126_5m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of warmest quarter,mean T of warmest qtr,year,degrees Celsius,*degree*C*, +bio11,bio11,WorldClim_2.1_ACCESS-CM2_ssp126_5m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of coldest quarter,mean T of coldest qtr,year,degrees Celsius,*degree*C*, +bio12,bio12,WorldClim_2.1_ACCESS-CM2_ssp126_5m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual precipitation,ann. P,year,mm per year,*mm~yr^-1*, +bio13,bio13,WorldClim_2.1_ACCESS-CM2_ssp126_5m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest month,P of wettest mo.,year,mm per month,*mm~mo^-1*, +bio14,bio14,WorldClim_2.1_ACCESS-CM2_ssp126_5m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest month,P of driest mo.,year,mm per month,*mm~mo^-1*, +bio15,bio15,WorldClim_2.1_ACCESS-CM2_ssp126_5m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation seasonality (coeff var),P season.,year,,, +bio16,bio16,WorldClim_2.1_ACCESS-CM2_ssp126_5m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest quarter,P of wettest qtr,year,mm per quarter,*mm~qtr^-1*, +bio17,bio17,WorldClim_2.1_ACCESS-CM2_ssp126_5m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest quarter,P of driest qtr,year,mm per quarter,*mm~qtr^-1*, +bio18,bio18,WorldClim_2.1_ACCESS-CM2_ssp126_5m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of warmest quarter,P of warmest qtr,year,mm per quarter,*mm~qtr^-1*, +bio19,bio19,WorldClim_2.1_ACCESS-CM2_ssp126_5m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of coldest quarter,P of coldest qtr,year,mm per quarter,*mm~qtr^-1*, +precipitation_01,precipitation_01,WorldClim_2.1_ACCESS-CM2_ssp126_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jan,P Jan,january,mm per month,*mm~mo^-1*, +precipitation_02,precipitation_02,WorldClim_2.1_ACCESS-CM2_ssp126_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Feb,P Feb,february,mm per month,*mm~mo^-1*, +precipitation_03,precipitation_03,WorldClim_2.1_ACCESS-CM2_ssp126_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Mar,P Mar,march,mm per month,*mm~mo^-1*, +precipitation_04,precipitation_04,WorldClim_2.1_ACCESS-CM2_ssp126_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Apr,P Apr,april,mm per month,*mm~mo^-1*, +precipitation_05,precipitation_05,WorldClim_2.1_ACCESS-CM2_ssp126_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation May,P May,may,mm per month,*mm~mo^-1*, +precipitation_06,precipitation_06,WorldClim_2.1_ACCESS-CM2_ssp126_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jun,P Jun,june,mm per month,*mm~mo^-1*, +precipitation_07,precipitation_07,WorldClim_2.1_ACCESS-CM2_ssp126_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jul,P Jul,july,mm per month,*mm~mo^-1*, +precipitation_08,precipitation_08,WorldClim_2.1_ACCESS-CM2_ssp126_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Aug,P Aug,august,mm per month,*mm~mo^-1*, +precipitation_09,precipitation_09,WorldClim_2.1_ACCESS-CM2_ssp126_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Sep,P Sep,september,mm per month,*mm~mo^-1*, +precipitation_10,precipitation_10,WorldClim_2.1_ACCESS-CM2_ssp126_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Oct,P Oct,october,mm per month,*mm~mo^-1*, +precipitation_11,precipitation_11,WorldClim_2.1_ACCESS-CM2_ssp126_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Nov,P Nov,november,mm per month,*mm~mo^-1*, +precipitation_12,precipitation_12,WorldClim_2.1_ACCESS-CM2_ssp126_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Dec,P Dec,december,mm per month,*mm~mo^-1*, +temperature_min_01,temperature_min_01,WorldClim_2.1_ACCESS-CM2_ssp126_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jan,min T Jan,january,degrees Celsius,*degree*C*, +temperature_min_02,temperature_min_02,WorldClim_2.1_ACCESS-CM2_ssp126_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Feb,min T Feb,february,degrees Celsius,*degree*C*, +temperature_min_03,temperature_min_03,WorldClim_2.1_ACCESS-CM2_ssp126_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Mar,min T Mar,march,degrees Celsius,*degree*C*, +temperature_min_04,temperature_min_04,WorldClim_2.1_ACCESS-CM2_ssp126_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Apr,min T Apr,april,degrees Celsius,*degree*C*, +temperature_min_05,temperature_min_05,WorldClim_2.1_ACCESS-CM2_ssp126_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature May,min T May,may,degrees Celsius,*degree*C*, +temperature_min_06,temperature_min_06,WorldClim_2.1_ACCESS-CM2_ssp126_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jun,min T Jun,june,degrees Celsius,*degree*C*, +temperature_min_07,temperature_min_07,WorldClim_2.1_ACCESS-CM2_ssp126_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jul,min T Jul,july,degrees Celsius,*degree*C*, +temperature_min_08,temperature_min_08,WorldClim_2.1_ACCESS-CM2_ssp126_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Aug,min T Aug,august,degrees Celsius,*degree*C*, +temperature_min_09,temperature_min_09,WorldClim_2.1_ACCESS-CM2_ssp126_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Sep,min T Sep,september,degrees Celsius,*degree*C*, +temperature_min_10,temperature_min_10,WorldClim_2.1_ACCESS-CM2_ssp126_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Oct,min T Oct,october,degrees Celsius,*degree*C*, +temperature_min_11,temperature_min_11,WorldClim_2.1_ACCESS-CM2_ssp126_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Nov,min T Nov,november,degrees Celsius,*degree*C*, +temperature_min_12,temperature_min_12,WorldClim_2.1_ACCESS-CM2_ssp126_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Dec,min T Dec,december,degrees Celsius,*degree*C*, +temperature_max_01,temperature_max_01,WorldClim_2.1_ACCESS-CM2_ssp126_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jan,max T Jan,january,degrees Celsius,*degree*C*, +temperature_max_02,temperature_max_02,WorldClim_2.1_ACCESS-CM2_ssp126_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Feb,max T Feb,february,degrees Celsius,*degree*C*, +temperature_max_03,temperature_max_03,WorldClim_2.1_ACCESS-CM2_ssp126_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Mar,max T Mar,march,degrees Celsius,*degree*C*, +temperature_max_04,temperature_max_04,WorldClim_2.1_ACCESS-CM2_ssp126_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Apr,max T Apr,april,degrees Celsius,*degree*C*, +temperature_max_05,temperature_max_05,WorldClim_2.1_ACCESS-CM2_ssp126_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature May,max T May,may,degrees Celsius,*degree*C*, +temperature_max_06,temperature_max_06,WorldClim_2.1_ACCESS-CM2_ssp126_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jun,max T Jun,june,degrees Celsius,*degree*C*, +temperature_max_07,temperature_max_07,WorldClim_2.1_ACCESS-CM2_ssp126_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jul,max T Jul,july,degrees Celsius,*degree*C*, +temperature_max_08,temperature_max_08,WorldClim_2.1_ACCESS-CM2_ssp126_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Aug,max T Aug,august,degrees Celsius,*degree*C*, +temperature_max_09,temperature_max_09,WorldClim_2.1_ACCESS-CM2_ssp126_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Sep,max T Sep,september,degrees Celsius,*degree*C*, +temperature_max_10,temperature_max_10,WorldClim_2.1_ACCESS-CM2_ssp126_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Oct,max T Oct,october,degrees Celsius,*degree*C*, +temperature_max_11,temperature_max_11,WorldClim_2.1_ACCESS-CM2_ssp126_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Nov,max T Nov,november,degrees Celsius,*degree*C*, +temperature_max_12,temperature_max_12,WorldClim_2.1_ACCESS-CM2_ssp126_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Dec,max T Dec,december,degrees Celsius,*degree*C*, +bio01,bio01,WorldClim_2.1_ACCESS-CM2_ssp245_10m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual mean temperature,ann. mean T,year,degrees Celsius,*degree*C*, +bio02,bio02,WorldClim_2.1_ACCESS-CM2_ssp245_10m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean diurnal range,diurn. range,year,degrees Celsius,*degree*C*, +bio03,bio03,WorldClim_2.1_ACCESS-CM2_ssp245_10m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,isothermality,isothermality,year,,, +bio04,bio04,WorldClim_2.1_ACCESS-CM2_ssp245_10m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature seasonality,T season.,year,degrees Celsius,*degree*C*, +bio05,bio05,WorldClim_2.1_ACCESS-CM2_ssp245_10m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature of warmest month,max. T of warmest mo.,year,degrees Celsius,*degree*C*, +bio06,bio06,WorldClim_2.1_ACCESS-CM2_ssp245_10m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature of coldest month,min. T of coldest mo.,year,degrees Celsius,*degree*C*, +bio07,bio07,WorldClim_2.1_ACCESS-CM2_ssp245_10m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature annual range (bio05-bio06),T ann. Range,year,degrees Celsius,*degree*C*, +bio08,bio08,WorldClim_2.1_ACCESS-CM2_ssp245_10m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of wettest quarter,mean T of wettest qtr,year,degrees Celsius,*degree*C*, +bio09,bio09,WorldClim_2.1_ACCESS-CM2_ssp245_10m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of driest quarter,mean T of driest qtr,year,degrees Celsius,*degree*C*, +bio10,bio10,WorldClim_2.1_ACCESS-CM2_ssp245_10m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of warmest quarter,mean T of warmest qtr,year,degrees Celsius,*degree*C*, +bio11,bio11,WorldClim_2.1_ACCESS-CM2_ssp245_10m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of coldest quarter,mean T of coldest qtr,year,degrees Celsius,*degree*C*, +bio12,bio12,WorldClim_2.1_ACCESS-CM2_ssp245_10m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual precipitation,ann. P,year,mm per year,*mm~yr^-1*, +bio13,bio13,WorldClim_2.1_ACCESS-CM2_ssp245_10m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest month,P of wettest mo.,year,mm per month,*mm~mo^-1*, +bio14,bio14,WorldClim_2.1_ACCESS-CM2_ssp245_10m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest month,P of driest mo.,year,mm per month,*mm~mo^-1*, +bio15,bio15,WorldClim_2.1_ACCESS-CM2_ssp245_10m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation seasonality (coeff var),P season.,year,,, +bio16,bio16,WorldClim_2.1_ACCESS-CM2_ssp245_10m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest quarter,P of wettest qtr,year,mm per quarter,*mm~qtr^-1*, +bio17,bio17,WorldClim_2.1_ACCESS-CM2_ssp245_10m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest quarter,P of driest qtr,year,mm per quarter,*mm~qtr^-1*, +bio18,bio18,WorldClim_2.1_ACCESS-CM2_ssp245_10m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of warmest quarter,P of warmest qtr,year,mm per quarter,*mm~qtr^-1*, +bio19,bio19,WorldClim_2.1_ACCESS-CM2_ssp245_10m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of coldest quarter,P of coldest qtr,year,mm per quarter,*mm~qtr^-1*, +precipitation_01,precipitation_01,WorldClim_2.1_ACCESS-CM2_ssp245_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jan,P Jan,january,mm per month,*mm~mo^-1*, +precipitation_02,precipitation_02,WorldClim_2.1_ACCESS-CM2_ssp245_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Feb,P Feb,february,mm per month,*mm~mo^-1*, +precipitation_03,precipitation_03,WorldClim_2.1_ACCESS-CM2_ssp245_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Mar,P Mar,march,mm per month,*mm~mo^-1*, +precipitation_04,precipitation_04,WorldClim_2.1_ACCESS-CM2_ssp245_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Apr,P Apr,april,mm per month,*mm~mo^-1*, +precipitation_05,precipitation_05,WorldClim_2.1_ACCESS-CM2_ssp245_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation May,P May,may,mm per month,*mm~mo^-1*, +precipitation_06,precipitation_06,WorldClim_2.1_ACCESS-CM2_ssp245_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jun,P Jun,june,mm per month,*mm~mo^-1*, +precipitation_07,precipitation_07,WorldClim_2.1_ACCESS-CM2_ssp245_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jul,P Jul,july,mm per month,*mm~mo^-1*, +precipitation_08,precipitation_08,WorldClim_2.1_ACCESS-CM2_ssp245_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Aug,P Aug,august,mm per month,*mm~mo^-1*, +precipitation_09,precipitation_09,WorldClim_2.1_ACCESS-CM2_ssp245_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Sep,P Sep,september,mm per month,*mm~mo^-1*, +precipitation_10,precipitation_10,WorldClim_2.1_ACCESS-CM2_ssp245_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Oct,P Oct,october,mm per month,*mm~mo^-1*, +precipitation_11,precipitation_11,WorldClim_2.1_ACCESS-CM2_ssp245_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Nov,P Nov,november,mm per month,*mm~mo^-1*, +precipitation_12,precipitation_12,WorldClim_2.1_ACCESS-CM2_ssp245_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Dec,P Dec,december,mm per month,*mm~mo^-1*, +temperature_min_01,temperature_min_01,WorldClim_2.1_ACCESS-CM2_ssp245_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jan,min T Jan,january,degrees Celsius,*degree*C*, +temperature_min_02,temperature_min_02,WorldClim_2.1_ACCESS-CM2_ssp245_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Feb,min T Feb,february,degrees Celsius,*degree*C*, +temperature_min_03,temperature_min_03,WorldClim_2.1_ACCESS-CM2_ssp245_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Mar,min T Mar,march,degrees Celsius,*degree*C*, +temperature_min_04,temperature_min_04,WorldClim_2.1_ACCESS-CM2_ssp245_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Apr,min T Apr,april,degrees Celsius,*degree*C*, +temperature_min_05,temperature_min_05,WorldClim_2.1_ACCESS-CM2_ssp245_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature May,min T May,may,degrees Celsius,*degree*C*, +temperature_min_06,temperature_min_06,WorldClim_2.1_ACCESS-CM2_ssp245_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jun,min T Jun,june,degrees Celsius,*degree*C*, +temperature_min_07,temperature_min_07,WorldClim_2.1_ACCESS-CM2_ssp245_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jul,min T Jul,july,degrees Celsius,*degree*C*, +temperature_min_08,temperature_min_08,WorldClim_2.1_ACCESS-CM2_ssp245_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Aug,min T Aug,august,degrees Celsius,*degree*C*, +temperature_min_09,temperature_min_09,WorldClim_2.1_ACCESS-CM2_ssp245_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Sep,min T Sep,september,degrees Celsius,*degree*C*, +temperature_min_10,temperature_min_10,WorldClim_2.1_ACCESS-CM2_ssp245_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Oct,min T Oct,october,degrees Celsius,*degree*C*, +temperature_min_11,temperature_min_11,WorldClim_2.1_ACCESS-CM2_ssp245_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Nov,min T Nov,november,degrees Celsius,*degree*C*, +temperature_min_12,temperature_min_12,WorldClim_2.1_ACCESS-CM2_ssp245_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Dec,min T Dec,december,degrees Celsius,*degree*C*, +temperature_max_01,temperature_max_01,WorldClim_2.1_ACCESS-CM2_ssp245_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jan,max T Jan,january,degrees Celsius,*degree*C*, +temperature_max_02,temperature_max_02,WorldClim_2.1_ACCESS-CM2_ssp245_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Feb,max T Feb,february,degrees Celsius,*degree*C*, +temperature_max_03,temperature_max_03,WorldClim_2.1_ACCESS-CM2_ssp245_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Mar,max T Mar,march,degrees Celsius,*degree*C*, +temperature_max_04,temperature_max_04,WorldClim_2.1_ACCESS-CM2_ssp245_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Apr,max T Apr,april,degrees Celsius,*degree*C*, +temperature_max_05,temperature_max_05,WorldClim_2.1_ACCESS-CM2_ssp245_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature May,max T May,may,degrees Celsius,*degree*C*, +temperature_max_06,temperature_max_06,WorldClim_2.1_ACCESS-CM2_ssp245_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jun,max T Jun,june,degrees Celsius,*degree*C*, +temperature_max_07,temperature_max_07,WorldClim_2.1_ACCESS-CM2_ssp245_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jul,max T Jul,july,degrees Celsius,*degree*C*, +temperature_max_08,temperature_max_08,WorldClim_2.1_ACCESS-CM2_ssp245_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Aug,max T Aug,august,degrees Celsius,*degree*C*, +temperature_max_09,temperature_max_09,WorldClim_2.1_ACCESS-CM2_ssp245_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Sep,max T Sep,september,degrees Celsius,*degree*C*, +temperature_max_10,temperature_max_10,WorldClim_2.1_ACCESS-CM2_ssp245_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Oct,max T Oct,october,degrees Celsius,*degree*C*, +temperature_max_11,temperature_max_11,WorldClim_2.1_ACCESS-CM2_ssp245_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Nov,max T Nov,november,degrees Celsius,*degree*C*, +temperature_max_12,temperature_max_12,WorldClim_2.1_ACCESS-CM2_ssp245_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Dec,max T Dec,december,degrees Celsius,*degree*C*, +bio01,bio01,WorldClim_2.1_ACCESS-CM2_ssp245_5m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual mean temperature,ann. mean T,year,degrees Celsius,*degree*C*, +bio02,bio02,WorldClim_2.1_ACCESS-CM2_ssp245_5m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean diurnal range,diurn. range,year,degrees Celsius,*degree*C*, +bio03,bio03,WorldClim_2.1_ACCESS-CM2_ssp245_5m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,isothermality,isothermality,year,,, +bio04,bio04,WorldClim_2.1_ACCESS-CM2_ssp245_5m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature seasonality,T season.,year,degrees Celsius,*degree*C*, +bio05,bio05,WorldClim_2.1_ACCESS-CM2_ssp245_5m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature of warmest month,max. T of warmest mo.,year,degrees Celsius,*degree*C*, +bio06,bio06,WorldClim_2.1_ACCESS-CM2_ssp245_5m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature of coldest month,min. T of coldest mo.,year,degrees Celsius,*degree*C*, +bio07,bio07,WorldClim_2.1_ACCESS-CM2_ssp245_5m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature annual range (bio05-bio06),T ann. Range,year,degrees Celsius,*degree*C*, +bio08,bio08,WorldClim_2.1_ACCESS-CM2_ssp245_5m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of wettest quarter,mean T of wettest qtr,year,degrees Celsius,*degree*C*, +bio09,bio09,WorldClim_2.1_ACCESS-CM2_ssp245_5m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of driest quarter,mean T of driest qtr,year,degrees Celsius,*degree*C*, +bio10,bio10,WorldClim_2.1_ACCESS-CM2_ssp245_5m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of warmest quarter,mean T of warmest qtr,year,degrees Celsius,*degree*C*, +bio11,bio11,WorldClim_2.1_ACCESS-CM2_ssp245_5m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of coldest quarter,mean T of coldest qtr,year,degrees Celsius,*degree*C*, +bio12,bio12,WorldClim_2.1_ACCESS-CM2_ssp245_5m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual precipitation,ann. P,year,mm per year,*mm~yr^-1*, +bio13,bio13,WorldClim_2.1_ACCESS-CM2_ssp245_5m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest month,P of wettest mo.,year,mm per month,*mm~mo^-1*, +bio14,bio14,WorldClim_2.1_ACCESS-CM2_ssp245_5m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest month,P of driest mo.,year,mm per month,*mm~mo^-1*, +bio15,bio15,WorldClim_2.1_ACCESS-CM2_ssp245_5m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation seasonality (coeff var),P season.,year,,, +bio16,bio16,WorldClim_2.1_ACCESS-CM2_ssp245_5m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest quarter,P of wettest qtr,year,mm per quarter,*mm~qtr^-1*, +bio17,bio17,WorldClim_2.1_ACCESS-CM2_ssp245_5m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest quarter,P of driest qtr,year,mm per quarter,*mm~qtr^-1*, +bio18,bio18,WorldClim_2.1_ACCESS-CM2_ssp245_5m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of warmest quarter,P of warmest qtr,year,mm per quarter,*mm~qtr^-1*, +bio19,bio19,WorldClim_2.1_ACCESS-CM2_ssp245_5m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of coldest quarter,P of coldest qtr,year,mm per quarter,*mm~qtr^-1*, +precipitation_01,precipitation_01,WorldClim_2.1_ACCESS-CM2_ssp245_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jan,P Jan,january,mm per month,*mm~mo^-1*, +precipitation_02,precipitation_02,WorldClim_2.1_ACCESS-CM2_ssp245_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Feb,P Feb,february,mm per month,*mm~mo^-1*, +precipitation_03,precipitation_03,WorldClim_2.1_ACCESS-CM2_ssp245_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Mar,P Mar,march,mm per month,*mm~mo^-1*, +precipitation_04,precipitation_04,WorldClim_2.1_ACCESS-CM2_ssp245_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Apr,P Apr,april,mm per month,*mm~mo^-1*, +precipitation_05,precipitation_05,WorldClim_2.1_ACCESS-CM2_ssp245_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation May,P May,may,mm per month,*mm~mo^-1*, +precipitation_06,precipitation_06,WorldClim_2.1_ACCESS-CM2_ssp245_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jun,P Jun,june,mm per month,*mm~mo^-1*, +precipitation_07,precipitation_07,WorldClim_2.1_ACCESS-CM2_ssp245_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jul,P Jul,july,mm per month,*mm~mo^-1*, +precipitation_08,precipitation_08,WorldClim_2.1_ACCESS-CM2_ssp245_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Aug,P Aug,august,mm per month,*mm~mo^-1*, +precipitation_09,precipitation_09,WorldClim_2.1_ACCESS-CM2_ssp245_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Sep,P Sep,september,mm per month,*mm~mo^-1*, +precipitation_10,precipitation_10,WorldClim_2.1_ACCESS-CM2_ssp245_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Oct,P Oct,october,mm per month,*mm~mo^-1*, +precipitation_11,precipitation_11,WorldClim_2.1_ACCESS-CM2_ssp245_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Nov,P Nov,november,mm per month,*mm~mo^-1*, +precipitation_12,precipitation_12,WorldClim_2.1_ACCESS-CM2_ssp245_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Dec,P Dec,december,mm per month,*mm~mo^-1*, +temperature_min_01,temperature_min_01,WorldClim_2.1_ACCESS-CM2_ssp245_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jan,min T Jan,january,degrees Celsius,*degree*C*, +temperature_min_02,temperature_min_02,WorldClim_2.1_ACCESS-CM2_ssp245_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Feb,min T Feb,february,degrees Celsius,*degree*C*, +temperature_min_03,temperature_min_03,WorldClim_2.1_ACCESS-CM2_ssp245_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Mar,min T Mar,march,degrees Celsius,*degree*C*, +temperature_min_04,temperature_min_04,WorldClim_2.1_ACCESS-CM2_ssp245_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Apr,min T Apr,april,degrees Celsius,*degree*C*, +temperature_min_05,temperature_min_05,WorldClim_2.1_ACCESS-CM2_ssp245_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature May,min T May,may,degrees Celsius,*degree*C*, +temperature_min_06,temperature_min_06,WorldClim_2.1_ACCESS-CM2_ssp245_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jun,min T Jun,june,degrees Celsius,*degree*C*, +temperature_min_07,temperature_min_07,WorldClim_2.1_ACCESS-CM2_ssp245_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jul,min T Jul,july,degrees Celsius,*degree*C*, +temperature_min_08,temperature_min_08,WorldClim_2.1_ACCESS-CM2_ssp245_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Aug,min T Aug,august,degrees Celsius,*degree*C*, +temperature_min_09,temperature_min_09,WorldClim_2.1_ACCESS-CM2_ssp245_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Sep,min T Sep,september,degrees Celsius,*degree*C*, +temperature_min_10,temperature_min_10,WorldClim_2.1_ACCESS-CM2_ssp245_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Oct,min T Oct,october,degrees Celsius,*degree*C*, +temperature_min_11,temperature_min_11,WorldClim_2.1_ACCESS-CM2_ssp245_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Nov,min T Nov,november,degrees Celsius,*degree*C*, +temperature_min_12,temperature_min_12,WorldClim_2.1_ACCESS-CM2_ssp245_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Dec,min T Dec,december,degrees Celsius,*degree*C*, +temperature_max_01,temperature_max_01,WorldClim_2.1_ACCESS-CM2_ssp245_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jan,max T Jan,january,degrees Celsius,*degree*C*, +temperature_max_02,temperature_max_02,WorldClim_2.1_ACCESS-CM2_ssp245_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Feb,max T Feb,february,degrees Celsius,*degree*C*, +temperature_max_03,temperature_max_03,WorldClim_2.1_ACCESS-CM2_ssp245_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Mar,max T Mar,march,degrees Celsius,*degree*C*, +temperature_max_04,temperature_max_04,WorldClim_2.1_ACCESS-CM2_ssp245_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Apr,max T Apr,april,degrees Celsius,*degree*C*, +temperature_max_05,temperature_max_05,WorldClim_2.1_ACCESS-CM2_ssp245_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature May,max T May,may,degrees Celsius,*degree*C*, +temperature_max_06,temperature_max_06,WorldClim_2.1_ACCESS-CM2_ssp245_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jun,max T Jun,june,degrees Celsius,*degree*C*, +temperature_max_07,temperature_max_07,WorldClim_2.1_ACCESS-CM2_ssp245_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jul,max T Jul,july,degrees Celsius,*degree*C*, +temperature_max_08,temperature_max_08,WorldClim_2.1_ACCESS-CM2_ssp245_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Aug,max T Aug,august,degrees Celsius,*degree*C*, +temperature_max_09,temperature_max_09,WorldClim_2.1_ACCESS-CM2_ssp245_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Sep,max T Sep,september,degrees Celsius,*degree*C*, +temperature_max_10,temperature_max_10,WorldClim_2.1_ACCESS-CM2_ssp245_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Oct,max T Oct,october,degrees Celsius,*degree*C*, +temperature_max_11,temperature_max_11,WorldClim_2.1_ACCESS-CM2_ssp245_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Nov,max T Nov,november,degrees Celsius,*degree*C*, +temperature_max_12,temperature_max_12,WorldClim_2.1_ACCESS-CM2_ssp245_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Dec,max T Dec,december,degrees Celsius,*degree*C*, +bio01,bio01,WorldClim_2.1_ACCESS-CM2_ssp370_10m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual mean temperature,ann. mean T,year,degrees Celsius,*degree*C*, +bio02,bio02,WorldClim_2.1_ACCESS-CM2_ssp370_10m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean diurnal range,diurn. range,year,degrees Celsius,*degree*C*, +bio03,bio03,WorldClim_2.1_ACCESS-CM2_ssp370_10m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,isothermality,isothermality,year,,, +bio04,bio04,WorldClim_2.1_ACCESS-CM2_ssp370_10m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature seasonality,T season.,year,degrees Celsius,*degree*C*, +bio05,bio05,WorldClim_2.1_ACCESS-CM2_ssp370_10m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature of warmest month,max. T of warmest mo.,year,degrees Celsius,*degree*C*, +bio06,bio06,WorldClim_2.1_ACCESS-CM2_ssp370_10m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature of coldest month,min. T of coldest mo.,year,degrees Celsius,*degree*C*, +bio07,bio07,WorldClim_2.1_ACCESS-CM2_ssp370_10m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature annual range (bio05-bio06),T ann. Range,year,degrees Celsius,*degree*C*, +bio08,bio08,WorldClim_2.1_ACCESS-CM2_ssp370_10m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of wettest quarter,mean T of wettest qtr,year,degrees Celsius,*degree*C*, +bio09,bio09,WorldClim_2.1_ACCESS-CM2_ssp370_10m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of driest quarter,mean T of driest qtr,year,degrees Celsius,*degree*C*, +bio10,bio10,WorldClim_2.1_ACCESS-CM2_ssp370_10m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of warmest quarter,mean T of warmest qtr,year,degrees Celsius,*degree*C*, +bio11,bio11,WorldClim_2.1_ACCESS-CM2_ssp370_10m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of coldest quarter,mean T of coldest qtr,year,degrees Celsius,*degree*C*, +bio12,bio12,WorldClim_2.1_ACCESS-CM2_ssp370_10m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual precipitation,ann. P,year,mm per year,*mm~yr^-1*, +bio13,bio13,WorldClim_2.1_ACCESS-CM2_ssp370_10m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest month,P of wettest mo.,year,mm per month,*mm~mo^-1*, +bio14,bio14,WorldClim_2.1_ACCESS-CM2_ssp370_10m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest month,P of driest mo.,year,mm per month,*mm~mo^-1*, +bio15,bio15,WorldClim_2.1_ACCESS-CM2_ssp370_10m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation seasonality (coeff var),P season.,year,,, +bio16,bio16,WorldClim_2.1_ACCESS-CM2_ssp370_10m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest quarter,P of wettest qtr,year,mm per quarter,*mm~qtr^-1*, +bio17,bio17,WorldClim_2.1_ACCESS-CM2_ssp370_10m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest quarter,P of driest qtr,year,mm per quarter,*mm~qtr^-1*, +bio18,bio18,WorldClim_2.1_ACCESS-CM2_ssp370_10m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of warmest quarter,P of warmest qtr,year,mm per quarter,*mm~qtr^-1*, +bio19,bio19,WorldClim_2.1_ACCESS-CM2_ssp370_10m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of coldest quarter,P of coldest qtr,year,mm per quarter,*mm~qtr^-1*, +precipitation_01,precipitation_01,WorldClim_2.1_ACCESS-CM2_ssp370_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jan,P Jan,january,mm per month,*mm~mo^-1*, +precipitation_02,precipitation_02,WorldClim_2.1_ACCESS-CM2_ssp370_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Feb,P Feb,february,mm per month,*mm~mo^-1*, +precipitation_03,precipitation_03,WorldClim_2.1_ACCESS-CM2_ssp370_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Mar,P Mar,march,mm per month,*mm~mo^-1*, +precipitation_04,precipitation_04,WorldClim_2.1_ACCESS-CM2_ssp370_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Apr,P Apr,april,mm per month,*mm~mo^-1*, +precipitation_05,precipitation_05,WorldClim_2.1_ACCESS-CM2_ssp370_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation May,P May,may,mm per month,*mm~mo^-1*, +precipitation_06,precipitation_06,WorldClim_2.1_ACCESS-CM2_ssp370_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jun,P Jun,june,mm per month,*mm~mo^-1*, +precipitation_07,precipitation_07,WorldClim_2.1_ACCESS-CM2_ssp370_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jul,P Jul,july,mm per month,*mm~mo^-1*, +precipitation_08,precipitation_08,WorldClim_2.1_ACCESS-CM2_ssp370_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Aug,P Aug,august,mm per month,*mm~mo^-1*, +precipitation_09,precipitation_09,WorldClim_2.1_ACCESS-CM2_ssp370_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Sep,P Sep,september,mm per month,*mm~mo^-1*, +precipitation_10,precipitation_10,WorldClim_2.1_ACCESS-CM2_ssp370_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Oct,P Oct,october,mm per month,*mm~mo^-1*, +precipitation_11,precipitation_11,WorldClim_2.1_ACCESS-CM2_ssp370_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Nov,P Nov,november,mm per month,*mm~mo^-1*, +precipitation_12,precipitation_12,WorldClim_2.1_ACCESS-CM2_ssp370_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Dec,P Dec,december,mm per month,*mm~mo^-1*, +temperature_min_01,temperature_min_01,WorldClim_2.1_ACCESS-CM2_ssp370_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jan,min T Jan,january,degrees Celsius,*degree*C*, +temperature_min_02,temperature_min_02,WorldClim_2.1_ACCESS-CM2_ssp370_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Feb,min T Feb,february,degrees Celsius,*degree*C*, +temperature_min_03,temperature_min_03,WorldClim_2.1_ACCESS-CM2_ssp370_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Mar,min T Mar,march,degrees Celsius,*degree*C*, +temperature_min_04,temperature_min_04,WorldClim_2.1_ACCESS-CM2_ssp370_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Apr,min T Apr,april,degrees Celsius,*degree*C*, +temperature_min_05,temperature_min_05,WorldClim_2.1_ACCESS-CM2_ssp370_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature May,min T May,may,degrees Celsius,*degree*C*, +temperature_min_06,temperature_min_06,WorldClim_2.1_ACCESS-CM2_ssp370_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jun,min T Jun,june,degrees Celsius,*degree*C*, +temperature_min_07,temperature_min_07,WorldClim_2.1_ACCESS-CM2_ssp370_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jul,min T Jul,july,degrees Celsius,*degree*C*, +temperature_min_08,temperature_min_08,WorldClim_2.1_ACCESS-CM2_ssp370_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Aug,min T Aug,august,degrees Celsius,*degree*C*, +temperature_min_09,temperature_min_09,WorldClim_2.1_ACCESS-CM2_ssp370_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Sep,min T Sep,september,degrees Celsius,*degree*C*, +temperature_min_10,temperature_min_10,WorldClim_2.1_ACCESS-CM2_ssp370_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Oct,min T Oct,october,degrees Celsius,*degree*C*, +temperature_min_11,temperature_min_11,WorldClim_2.1_ACCESS-CM2_ssp370_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Nov,min T Nov,november,degrees Celsius,*degree*C*, +temperature_min_12,temperature_min_12,WorldClim_2.1_ACCESS-CM2_ssp370_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Dec,min T Dec,december,degrees Celsius,*degree*C*, +temperature_max_01,temperature_max_01,WorldClim_2.1_ACCESS-CM2_ssp370_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jan,max T Jan,january,degrees Celsius,*degree*C*, +temperature_max_02,temperature_max_02,WorldClim_2.1_ACCESS-CM2_ssp370_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Feb,max T Feb,february,degrees Celsius,*degree*C*, +temperature_max_03,temperature_max_03,WorldClim_2.1_ACCESS-CM2_ssp370_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Mar,max T Mar,march,degrees Celsius,*degree*C*, +temperature_max_04,temperature_max_04,WorldClim_2.1_ACCESS-CM2_ssp370_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Apr,max T Apr,april,degrees Celsius,*degree*C*, +temperature_max_05,temperature_max_05,WorldClim_2.1_ACCESS-CM2_ssp370_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature May,max T May,may,degrees Celsius,*degree*C*, +temperature_max_06,temperature_max_06,WorldClim_2.1_ACCESS-CM2_ssp370_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jun,max T Jun,june,degrees Celsius,*degree*C*, +temperature_max_07,temperature_max_07,WorldClim_2.1_ACCESS-CM2_ssp370_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jul,max T Jul,july,degrees Celsius,*degree*C*, +temperature_max_08,temperature_max_08,WorldClim_2.1_ACCESS-CM2_ssp370_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Aug,max T Aug,august,degrees Celsius,*degree*C*, +temperature_max_09,temperature_max_09,WorldClim_2.1_ACCESS-CM2_ssp370_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Sep,max T Sep,september,degrees Celsius,*degree*C*, +temperature_max_10,temperature_max_10,WorldClim_2.1_ACCESS-CM2_ssp370_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Oct,max T Oct,october,degrees Celsius,*degree*C*, +temperature_max_11,temperature_max_11,WorldClim_2.1_ACCESS-CM2_ssp370_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Nov,max T Nov,november,degrees Celsius,*degree*C*, +temperature_max_12,temperature_max_12,WorldClim_2.1_ACCESS-CM2_ssp370_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Dec,max T Dec,december,degrees Celsius,*degree*C*, +bio01,bio01,WorldClim_2.1_ACCESS-CM2_ssp370_5m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual mean temperature,ann. mean T,year,degrees Celsius,*degree*C*, +bio02,bio02,WorldClim_2.1_ACCESS-CM2_ssp370_5m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean diurnal range,diurn. range,year,degrees Celsius,*degree*C*, +bio03,bio03,WorldClim_2.1_ACCESS-CM2_ssp370_5m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,isothermality,isothermality,year,,, +bio04,bio04,WorldClim_2.1_ACCESS-CM2_ssp370_5m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature seasonality,T season.,year,degrees Celsius,*degree*C*, +bio05,bio05,WorldClim_2.1_ACCESS-CM2_ssp370_5m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature of warmest month,max. T of warmest mo.,year,degrees Celsius,*degree*C*, +bio06,bio06,WorldClim_2.1_ACCESS-CM2_ssp370_5m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature of coldest month,min. T of coldest mo.,year,degrees Celsius,*degree*C*, +bio07,bio07,WorldClim_2.1_ACCESS-CM2_ssp370_5m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature annual range (bio05-bio06),T ann. Range,year,degrees Celsius,*degree*C*, +bio08,bio08,WorldClim_2.1_ACCESS-CM2_ssp370_5m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of wettest quarter,mean T of wettest qtr,year,degrees Celsius,*degree*C*, +bio09,bio09,WorldClim_2.1_ACCESS-CM2_ssp370_5m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of driest quarter,mean T of driest qtr,year,degrees Celsius,*degree*C*, +bio10,bio10,WorldClim_2.1_ACCESS-CM2_ssp370_5m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of warmest quarter,mean T of warmest qtr,year,degrees Celsius,*degree*C*, +bio11,bio11,WorldClim_2.1_ACCESS-CM2_ssp370_5m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of coldest quarter,mean T of coldest qtr,year,degrees Celsius,*degree*C*, +bio12,bio12,WorldClim_2.1_ACCESS-CM2_ssp370_5m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual precipitation,ann. P,year,mm per year,*mm~yr^-1*, +bio13,bio13,WorldClim_2.1_ACCESS-CM2_ssp370_5m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest month,P of wettest mo.,year,mm per month,*mm~mo^-1*, +bio14,bio14,WorldClim_2.1_ACCESS-CM2_ssp370_5m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest month,P of driest mo.,year,mm per month,*mm~mo^-1*, +bio15,bio15,WorldClim_2.1_ACCESS-CM2_ssp370_5m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation seasonality (coeff var),P season.,year,,, +bio16,bio16,WorldClim_2.1_ACCESS-CM2_ssp370_5m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest quarter,P of wettest qtr,year,mm per quarter,*mm~qtr^-1*, +bio17,bio17,WorldClim_2.1_ACCESS-CM2_ssp370_5m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest quarter,P of driest qtr,year,mm per quarter,*mm~qtr^-1*, +bio18,bio18,WorldClim_2.1_ACCESS-CM2_ssp370_5m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of warmest quarter,P of warmest qtr,year,mm per quarter,*mm~qtr^-1*, +bio19,bio19,WorldClim_2.1_ACCESS-CM2_ssp370_5m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of coldest quarter,P of coldest qtr,year,mm per quarter,*mm~qtr^-1*, +precipitation_01,precipitation_01,WorldClim_2.1_ACCESS-CM2_ssp370_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jan,P Jan,january,mm per month,*mm~mo^-1*, +precipitation_02,precipitation_02,WorldClim_2.1_ACCESS-CM2_ssp370_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Feb,P Feb,february,mm per month,*mm~mo^-1*, +precipitation_03,precipitation_03,WorldClim_2.1_ACCESS-CM2_ssp370_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Mar,P Mar,march,mm per month,*mm~mo^-1*, +precipitation_04,precipitation_04,WorldClim_2.1_ACCESS-CM2_ssp370_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Apr,P Apr,april,mm per month,*mm~mo^-1*, +precipitation_05,precipitation_05,WorldClim_2.1_ACCESS-CM2_ssp370_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation May,P May,may,mm per month,*mm~mo^-1*, +precipitation_06,precipitation_06,WorldClim_2.1_ACCESS-CM2_ssp370_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jun,P Jun,june,mm per month,*mm~mo^-1*, +precipitation_07,precipitation_07,WorldClim_2.1_ACCESS-CM2_ssp370_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jul,P Jul,july,mm per month,*mm~mo^-1*, +precipitation_08,precipitation_08,WorldClim_2.1_ACCESS-CM2_ssp370_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Aug,P Aug,august,mm per month,*mm~mo^-1*, +precipitation_09,precipitation_09,WorldClim_2.1_ACCESS-CM2_ssp370_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Sep,P Sep,september,mm per month,*mm~mo^-1*, +precipitation_10,precipitation_10,WorldClim_2.1_ACCESS-CM2_ssp370_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Oct,P Oct,october,mm per month,*mm~mo^-1*, +precipitation_11,precipitation_11,WorldClim_2.1_ACCESS-CM2_ssp370_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Nov,P Nov,november,mm per month,*mm~mo^-1*, +precipitation_12,precipitation_12,WorldClim_2.1_ACCESS-CM2_ssp370_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Dec,P Dec,december,mm per month,*mm~mo^-1*, +temperature_min_01,temperature_min_01,WorldClim_2.1_ACCESS-CM2_ssp370_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jan,min T Jan,january,degrees Celsius,*degree*C*, +temperature_min_02,temperature_min_02,WorldClim_2.1_ACCESS-CM2_ssp370_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Feb,min T Feb,february,degrees Celsius,*degree*C*, +temperature_min_03,temperature_min_03,WorldClim_2.1_ACCESS-CM2_ssp370_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Mar,min T Mar,march,degrees Celsius,*degree*C*, +temperature_min_04,temperature_min_04,WorldClim_2.1_ACCESS-CM2_ssp370_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Apr,min T Apr,april,degrees Celsius,*degree*C*, +temperature_min_05,temperature_min_05,WorldClim_2.1_ACCESS-CM2_ssp370_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature May,min T May,may,degrees Celsius,*degree*C*, +temperature_min_06,temperature_min_06,WorldClim_2.1_ACCESS-CM2_ssp370_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jun,min T Jun,june,degrees Celsius,*degree*C*, +temperature_min_07,temperature_min_07,WorldClim_2.1_ACCESS-CM2_ssp370_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jul,min T Jul,july,degrees Celsius,*degree*C*, +temperature_min_08,temperature_min_08,WorldClim_2.1_ACCESS-CM2_ssp370_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Aug,min T Aug,august,degrees Celsius,*degree*C*, +temperature_min_09,temperature_min_09,WorldClim_2.1_ACCESS-CM2_ssp370_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Sep,min T Sep,september,degrees Celsius,*degree*C*, +temperature_min_10,temperature_min_10,WorldClim_2.1_ACCESS-CM2_ssp370_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Oct,min T Oct,october,degrees Celsius,*degree*C*, +temperature_min_11,temperature_min_11,WorldClim_2.1_ACCESS-CM2_ssp370_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Nov,min T Nov,november,degrees Celsius,*degree*C*, +temperature_min_12,temperature_min_12,WorldClim_2.1_ACCESS-CM2_ssp370_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Dec,min T Dec,december,degrees Celsius,*degree*C*, +temperature_max_01,temperature_max_01,WorldClim_2.1_ACCESS-CM2_ssp370_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jan,max T Jan,january,degrees Celsius,*degree*C*, +temperature_max_02,temperature_max_02,WorldClim_2.1_ACCESS-CM2_ssp370_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Feb,max T Feb,february,degrees Celsius,*degree*C*, +temperature_max_03,temperature_max_03,WorldClim_2.1_ACCESS-CM2_ssp370_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Mar,max T Mar,march,degrees Celsius,*degree*C*, +temperature_max_04,temperature_max_04,WorldClim_2.1_ACCESS-CM2_ssp370_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Apr,max T Apr,april,degrees Celsius,*degree*C*, +temperature_max_05,temperature_max_05,WorldClim_2.1_ACCESS-CM2_ssp370_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature May,max T May,may,degrees Celsius,*degree*C*, +temperature_max_06,temperature_max_06,WorldClim_2.1_ACCESS-CM2_ssp370_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jun,max T Jun,june,degrees Celsius,*degree*C*, +temperature_max_07,temperature_max_07,WorldClim_2.1_ACCESS-CM2_ssp370_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jul,max T Jul,july,degrees Celsius,*degree*C*, +temperature_max_08,temperature_max_08,WorldClim_2.1_ACCESS-CM2_ssp370_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Aug,max T Aug,august,degrees Celsius,*degree*C*, +temperature_max_09,temperature_max_09,WorldClim_2.1_ACCESS-CM2_ssp370_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Sep,max T Sep,september,degrees Celsius,*degree*C*, +temperature_max_10,temperature_max_10,WorldClim_2.1_ACCESS-CM2_ssp370_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Oct,max T Oct,october,degrees Celsius,*degree*C*, +temperature_max_11,temperature_max_11,WorldClim_2.1_ACCESS-CM2_ssp370_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Nov,max T Nov,november,degrees Celsius,*degree*C*, +temperature_max_12,temperature_max_12,WorldClim_2.1_ACCESS-CM2_ssp370_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Dec,max T Dec,december,degrees Celsius,*degree*C*, +bio01,bio01,WorldClim_2.1_ACCESS-CM2_ssp585_10m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual mean temperature,ann. mean T,year,degrees Celsius,*degree*C*, +bio02,bio02,WorldClim_2.1_ACCESS-CM2_ssp585_10m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean diurnal range,diurn. range,year,degrees Celsius,*degree*C*, +bio03,bio03,WorldClim_2.1_ACCESS-CM2_ssp585_10m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,isothermality,isothermality,year,,, +bio04,bio04,WorldClim_2.1_ACCESS-CM2_ssp585_10m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature seasonality,T season.,year,degrees Celsius,*degree*C*, +bio05,bio05,WorldClim_2.1_ACCESS-CM2_ssp585_10m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature of warmest month,max. T of warmest mo.,year,degrees Celsius,*degree*C*, +bio06,bio06,WorldClim_2.1_ACCESS-CM2_ssp585_10m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature of coldest month,min. T of coldest mo.,year,degrees Celsius,*degree*C*, +bio07,bio07,WorldClim_2.1_ACCESS-CM2_ssp585_10m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature annual range (bio05-bio06),T ann. Range,year,degrees Celsius,*degree*C*, +bio08,bio08,WorldClim_2.1_ACCESS-CM2_ssp585_10m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of wettest quarter,mean T of wettest qtr,year,degrees Celsius,*degree*C*, +bio09,bio09,WorldClim_2.1_ACCESS-CM2_ssp585_10m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of driest quarter,mean T of driest qtr,year,degrees Celsius,*degree*C*, +bio10,bio10,WorldClim_2.1_ACCESS-CM2_ssp585_10m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of warmest quarter,mean T of warmest qtr,year,degrees Celsius,*degree*C*, +bio11,bio11,WorldClim_2.1_ACCESS-CM2_ssp585_10m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of coldest quarter,mean T of coldest qtr,year,degrees Celsius,*degree*C*, +bio12,bio12,WorldClim_2.1_ACCESS-CM2_ssp585_10m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual precipitation,ann. P,year,mm per year,*mm~yr^-1*, +bio13,bio13,WorldClim_2.1_ACCESS-CM2_ssp585_10m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest month,P of wettest mo.,year,mm per month,*mm~mo^-1*, +bio14,bio14,WorldClim_2.1_ACCESS-CM2_ssp585_10m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest month,P of driest mo.,year,mm per month,*mm~mo^-1*, +bio15,bio15,WorldClim_2.1_ACCESS-CM2_ssp585_10m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation seasonality (coeff var),P season.,year,,, +bio16,bio16,WorldClim_2.1_ACCESS-CM2_ssp585_10m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest quarter,P of wettest qtr,year,mm per quarter,*mm~qtr^-1*, +bio17,bio17,WorldClim_2.1_ACCESS-CM2_ssp585_10m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest quarter,P of driest qtr,year,mm per quarter,*mm~qtr^-1*, +bio18,bio18,WorldClim_2.1_ACCESS-CM2_ssp585_10m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of warmest quarter,P of warmest qtr,year,mm per quarter,*mm~qtr^-1*, +bio19,bio19,WorldClim_2.1_ACCESS-CM2_ssp585_10m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of coldest quarter,P of coldest qtr,year,mm per quarter,*mm~qtr^-1*, +precipitation_01,precipitation_01,WorldClim_2.1_ACCESS-CM2_ssp585_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jan,P Jan,january,mm per month,*mm~mo^-1*, +precipitation_02,precipitation_02,WorldClim_2.1_ACCESS-CM2_ssp585_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Feb,P Feb,february,mm per month,*mm~mo^-1*, +precipitation_03,precipitation_03,WorldClim_2.1_ACCESS-CM2_ssp585_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Mar,P Mar,march,mm per month,*mm~mo^-1*, +precipitation_04,precipitation_04,WorldClim_2.1_ACCESS-CM2_ssp585_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Apr,P Apr,april,mm per month,*mm~mo^-1*, +precipitation_05,precipitation_05,WorldClim_2.1_ACCESS-CM2_ssp585_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation May,P May,may,mm per month,*mm~mo^-1*, +precipitation_06,precipitation_06,WorldClim_2.1_ACCESS-CM2_ssp585_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jun,P Jun,june,mm per month,*mm~mo^-1*, +precipitation_07,precipitation_07,WorldClim_2.1_ACCESS-CM2_ssp585_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jul,P Jul,july,mm per month,*mm~mo^-1*, +precipitation_08,precipitation_08,WorldClim_2.1_ACCESS-CM2_ssp585_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Aug,P Aug,august,mm per month,*mm~mo^-1*, +precipitation_09,precipitation_09,WorldClim_2.1_ACCESS-CM2_ssp585_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Sep,P Sep,september,mm per month,*mm~mo^-1*, +precipitation_10,precipitation_10,WorldClim_2.1_ACCESS-CM2_ssp585_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Oct,P Oct,october,mm per month,*mm~mo^-1*, +precipitation_11,precipitation_11,WorldClim_2.1_ACCESS-CM2_ssp585_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Nov,P Nov,november,mm per month,*mm~mo^-1*, +precipitation_12,precipitation_12,WorldClim_2.1_ACCESS-CM2_ssp585_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Dec,P Dec,december,mm per month,*mm~mo^-1*, +temperature_min_01,temperature_min_01,WorldClim_2.1_ACCESS-CM2_ssp585_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jan,min T Jan,january,degrees Celsius,*degree*C*, +temperature_min_02,temperature_min_02,WorldClim_2.1_ACCESS-CM2_ssp585_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Feb,min T Feb,february,degrees Celsius,*degree*C*, +temperature_min_03,temperature_min_03,WorldClim_2.1_ACCESS-CM2_ssp585_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Mar,min T Mar,march,degrees Celsius,*degree*C*, +temperature_min_04,temperature_min_04,WorldClim_2.1_ACCESS-CM2_ssp585_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Apr,min T Apr,april,degrees Celsius,*degree*C*, +temperature_min_05,temperature_min_05,WorldClim_2.1_ACCESS-CM2_ssp585_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature May,min T May,may,degrees Celsius,*degree*C*, +temperature_min_06,temperature_min_06,WorldClim_2.1_ACCESS-CM2_ssp585_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jun,min T Jun,june,degrees Celsius,*degree*C*, +temperature_min_07,temperature_min_07,WorldClim_2.1_ACCESS-CM2_ssp585_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jul,min T Jul,july,degrees Celsius,*degree*C*, +temperature_min_08,temperature_min_08,WorldClim_2.1_ACCESS-CM2_ssp585_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Aug,min T Aug,august,degrees Celsius,*degree*C*, +temperature_min_09,temperature_min_09,WorldClim_2.1_ACCESS-CM2_ssp585_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Sep,min T Sep,september,degrees Celsius,*degree*C*, +temperature_min_10,temperature_min_10,WorldClim_2.1_ACCESS-CM2_ssp585_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Oct,min T Oct,october,degrees Celsius,*degree*C*, +temperature_min_11,temperature_min_11,WorldClim_2.1_ACCESS-CM2_ssp585_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Nov,min T Nov,november,degrees Celsius,*degree*C*, +temperature_min_12,temperature_min_12,WorldClim_2.1_ACCESS-CM2_ssp585_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Dec,min T Dec,december,degrees Celsius,*degree*C*, +temperature_max_01,temperature_max_01,WorldClim_2.1_ACCESS-CM2_ssp585_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jan,max T Jan,january,degrees Celsius,*degree*C*, +temperature_max_02,temperature_max_02,WorldClim_2.1_ACCESS-CM2_ssp585_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Feb,max T Feb,february,degrees Celsius,*degree*C*, +temperature_max_03,temperature_max_03,WorldClim_2.1_ACCESS-CM2_ssp585_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Mar,max T Mar,march,degrees Celsius,*degree*C*, +temperature_max_04,temperature_max_04,WorldClim_2.1_ACCESS-CM2_ssp585_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Apr,max T Apr,april,degrees Celsius,*degree*C*, +temperature_max_05,temperature_max_05,WorldClim_2.1_ACCESS-CM2_ssp585_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature May,max T May,may,degrees Celsius,*degree*C*, +temperature_max_06,temperature_max_06,WorldClim_2.1_ACCESS-CM2_ssp585_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jun,max T Jun,june,degrees Celsius,*degree*C*, +temperature_max_07,temperature_max_07,WorldClim_2.1_ACCESS-CM2_ssp585_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jul,max T Jul,july,degrees Celsius,*degree*C*, +temperature_max_08,temperature_max_08,WorldClim_2.1_ACCESS-CM2_ssp585_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Aug,max T Aug,august,degrees Celsius,*degree*C*, +temperature_max_09,temperature_max_09,WorldClim_2.1_ACCESS-CM2_ssp585_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Sep,max T Sep,september,degrees Celsius,*degree*C*, +temperature_max_10,temperature_max_10,WorldClim_2.1_ACCESS-CM2_ssp585_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Oct,max T Oct,october,degrees Celsius,*degree*C*, +temperature_max_11,temperature_max_11,WorldClim_2.1_ACCESS-CM2_ssp585_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Nov,max T Nov,november,degrees Celsius,*degree*C*, +temperature_max_12,temperature_max_12,WorldClim_2.1_ACCESS-CM2_ssp585_10m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Dec,max T Dec,december,degrees Celsius,*degree*C*, +bio01,bio01,WorldClim_2.1_ACCESS-CM2_ssp585_5m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual mean temperature,ann. mean T,year,degrees Celsius,*degree*C*, +bio02,bio02,WorldClim_2.1_ACCESS-CM2_ssp585_5m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean diurnal range,diurn. range,year,degrees Celsius,*degree*C*, +bio03,bio03,WorldClim_2.1_ACCESS-CM2_ssp585_5m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,isothermality,isothermality,year,,, +bio04,bio04,WorldClim_2.1_ACCESS-CM2_ssp585_5m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature seasonality,T season.,year,degrees Celsius,*degree*C*, +bio05,bio05,WorldClim_2.1_ACCESS-CM2_ssp585_5m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature of warmest month,max. T of warmest mo.,year,degrees Celsius,*degree*C*, +bio06,bio06,WorldClim_2.1_ACCESS-CM2_ssp585_5m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature of coldest month,min. T of coldest mo.,year,degrees Celsius,*degree*C*, +bio07,bio07,WorldClim_2.1_ACCESS-CM2_ssp585_5m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature annual range (bio05-bio06),T ann. Range,year,degrees Celsius,*degree*C*, +bio08,bio08,WorldClim_2.1_ACCESS-CM2_ssp585_5m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of wettest quarter,mean T of wettest qtr,year,degrees Celsius,*degree*C*, +bio09,bio09,WorldClim_2.1_ACCESS-CM2_ssp585_5m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of driest quarter,mean T of driest qtr,year,degrees Celsius,*degree*C*, +bio10,bio10,WorldClim_2.1_ACCESS-CM2_ssp585_5m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of warmest quarter,mean T of warmest qtr,year,degrees Celsius,*degree*C*, +bio11,bio11,WorldClim_2.1_ACCESS-CM2_ssp585_5m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of coldest quarter,mean T of coldest qtr,year,degrees Celsius,*degree*C*, +bio12,bio12,WorldClim_2.1_ACCESS-CM2_ssp585_5m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual precipitation,ann. P,year,mm per year,*mm~yr^-1*, +bio13,bio13,WorldClim_2.1_ACCESS-CM2_ssp585_5m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest month,P of wettest mo.,year,mm per month,*mm~mo^-1*, +bio14,bio14,WorldClim_2.1_ACCESS-CM2_ssp585_5m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest month,P of driest mo.,year,mm per month,*mm~mo^-1*, +bio15,bio15,WorldClim_2.1_ACCESS-CM2_ssp585_5m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation seasonality (coeff var),P season.,year,,, +bio16,bio16,WorldClim_2.1_ACCESS-CM2_ssp585_5m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest quarter,P of wettest qtr,year,mm per quarter,*mm~qtr^-1*, +bio17,bio17,WorldClim_2.1_ACCESS-CM2_ssp585_5m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest quarter,P of driest qtr,year,mm per quarter,*mm~qtr^-1*, +bio18,bio18,WorldClim_2.1_ACCESS-CM2_ssp585_5m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of warmest quarter,P of warmest qtr,year,mm per quarter,*mm~qtr^-1*, +bio19,bio19,WorldClim_2.1_ACCESS-CM2_ssp585_5m,FALSE,WorldClim_2.1_ACCESS-CM2_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of coldest quarter,P of coldest qtr,year,mm per quarter,*mm~qtr^-1*, +precipitation_01,precipitation_01,WorldClim_2.1_ACCESS-CM2_ssp585_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jan,P Jan,january,mm per month,*mm~mo^-1*, +precipitation_02,precipitation_02,WorldClim_2.1_ACCESS-CM2_ssp585_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Feb,P Feb,february,mm per month,*mm~mo^-1*, +precipitation_03,precipitation_03,WorldClim_2.1_ACCESS-CM2_ssp585_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Mar,P Mar,march,mm per month,*mm~mo^-1*, +precipitation_04,precipitation_04,WorldClim_2.1_ACCESS-CM2_ssp585_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Apr,P Apr,april,mm per month,*mm~mo^-1*, +precipitation_05,precipitation_05,WorldClim_2.1_ACCESS-CM2_ssp585_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation May,P May,may,mm per month,*mm~mo^-1*, +precipitation_06,precipitation_06,WorldClim_2.1_ACCESS-CM2_ssp585_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jun,P Jun,june,mm per month,*mm~mo^-1*, +precipitation_07,precipitation_07,WorldClim_2.1_ACCESS-CM2_ssp585_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jul,P Jul,july,mm per month,*mm~mo^-1*, +precipitation_08,precipitation_08,WorldClim_2.1_ACCESS-CM2_ssp585_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Aug,P Aug,august,mm per month,*mm~mo^-1*, +precipitation_09,precipitation_09,WorldClim_2.1_ACCESS-CM2_ssp585_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Sep,P Sep,september,mm per month,*mm~mo^-1*, +precipitation_10,precipitation_10,WorldClim_2.1_ACCESS-CM2_ssp585_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Oct,P Oct,october,mm per month,*mm~mo^-1*, +precipitation_11,precipitation_11,WorldClim_2.1_ACCESS-CM2_ssp585_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Nov,P Nov,november,mm per month,*mm~mo^-1*, +precipitation_12,precipitation_12,WorldClim_2.1_ACCESS-CM2_ssp585_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Dec,P Dec,december,mm per month,*mm~mo^-1*, +temperature_min_01,temperature_min_01,WorldClim_2.1_ACCESS-CM2_ssp585_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jan,min T Jan,january,degrees Celsius,*degree*C*, +temperature_min_02,temperature_min_02,WorldClim_2.1_ACCESS-CM2_ssp585_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Feb,min T Feb,february,degrees Celsius,*degree*C*, +temperature_min_03,temperature_min_03,WorldClim_2.1_ACCESS-CM2_ssp585_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Mar,min T Mar,march,degrees Celsius,*degree*C*, +temperature_min_04,temperature_min_04,WorldClim_2.1_ACCESS-CM2_ssp585_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Apr,min T Apr,april,degrees Celsius,*degree*C*, +temperature_min_05,temperature_min_05,WorldClim_2.1_ACCESS-CM2_ssp585_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature May,min T May,may,degrees Celsius,*degree*C*, +temperature_min_06,temperature_min_06,WorldClim_2.1_ACCESS-CM2_ssp585_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jun,min T Jun,june,degrees Celsius,*degree*C*, +temperature_min_07,temperature_min_07,WorldClim_2.1_ACCESS-CM2_ssp585_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jul,min T Jul,july,degrees Celsius,*degree*C*, +temperature_min_08,temperature_min_08,WorldClim_2.1_ACCESS-CM2_ssp585_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Aug,min T Aug,august,degrees Celsius,*degree*C*, +temperature_min_09,temperature_min_09,WorldClim_2.1_ACCESS-CM2_ssp585_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Sep,min T Sep,september,degrees Celsius,*degree*C*, +temperature_min_10,temperature_min_10,WorldClim_2.1_ACCESS-CM2_ssp585_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Oct,min T Oct,october,degrees Celsius,*degree*C*, +temperature_min_11,temperature_min_11,WorldClim_2.1_ACCESS-CM2_ssp585_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Nov,min T Nov,november,degrees Celsius,*degree*C*, +temperature_min_12,temperature_min_12,WorldClim_2.1_ACCESS-CM2_ssp585_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Dec,min T Dec,december,degrees Celsius,*degree*C*, +temperature_max_01,temperature_max_01,WorldClim_2.1_ACCESS-CM2_ssp585_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jan,max T Jan,january,degrees Celsius,*degree*C*, +temperature_max_02,temperature_max_02,WorldClim_2.1_ACCESS-CM2_ssp585_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Feb,max T Feb,february,degrees Celsius,*degree*C*, +temperature_max_03,temperature_max_03,WorldClim_2.1_ACCESS-CM2_ssp585_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Mar,max T Mar,march,degrees Celsius,*degree*C*, +temperature_max_04,temperature_max_04,WorldClim_2.1_ACCESS-CM2_ssp585_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Apr,max T Apr,april,degrees Celsius,*degree*C*, +temperature_max_05,temperature_max_05,WorldClim_2.1_ACCESS-CM2_ssp585_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature May,max T May,may,degrees Celsius,*degree*C*, +temperature_max_06,temperature_max_06,WorldClim_2.1_ACCESS-CM2_ssp585_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jun,max T Jun,june,degrees Celsius,*degree*C*, +temperature_max_07,temperature_max_07,WorldClim_2.1_ACCESS-CM2_ssp585_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jul,max T Jul,july,degrees Celsius,*degree*C*, +temperature_max_08,temperature_max_08,WorldClim_2.1_ACCESS-CM2_ssp585_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Aug,max T Aug,august,degrees Celsius,*degree*C*, +temperature_max_09,temperature_max_09,WorldClim_2.1_ACCESS-CM2_ssp585_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Sep,max T Sep,september,degrees Celsius,*degree*C*, +temperature_max_10,temperature_max_10,WorldClim_2.1_ACCESS-CM2_ssp585_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Oct,max T Oct,october,degrees Celsius,*degree*C*, +temperature_max_11,temperature_max_11,WorldClim_2.1_ACCESS-CM2_ssp585_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Nov,max T Nov,november,degrees Celsius,*degree*C*, +temperature_max_12,temperature_max_12,WorldClim_2.1_ACCESS-CM2_ssp585_5m,TRUE,WorldClim_2.1_ACCESS-CM2_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Dec,max T Dec,december,degrees Celsius,*degree*C*, +bio01,bio01,WorldClim_2.1_BCC-CSM2-MR_ssp126_10m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual mean temperature,ann. mean T,year,degrees Celsius,*degree*C*, +bio02,bio02,WorldClim_2.1_BCC-CSM2-MR_ssp126_10m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean diurnal range,diurn. range,year,degrees Celsius,*degree*C*, +bio03,bio03,WorldClim_2.1_BCC-CSM2-MR_ssp126_10m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,isothermality,isothermality,year,,, +bio04,bio04,WorldClim_2.1_BCC-CSM2-MR_ssp126_10m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature seasonality,T season.,year,degrees Celsius,*degree*C*, +bio05,bio05,WorldClim_2.1_BCC-CSM2-MR_ssp126_10m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature of warmest month,max. T of warmest mo.,year,degrees Celsius,*degree*C*, +bio06,bio06,WorldClim_2.1_BCC-CSM2-MR_ssp126_10m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature of coldest month,min. T of coldest mo.,year,degrees Celsius,*degree*C*, +bio07,bio07,WorldClim_2.1_BCC-CSM2-MR_ssp126_10m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature annual range (bio05-bio06),T ann. Range,year,degrees Celsius,*degree*C*, +bio08,bio08,WorldClim_2.1_BCC-CSM2-MR_ssp126_10m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of wettest quarter,mean T of wettest qtr,year,degrees Celsius,*degree*C*, +bio09,bio09,WorldClim_2.1_BCC-CSM2-MR_ssp126_10m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of driest quarter,mean T of driest qtr,year,degrees Celsius,*degree*C*, +bio10,bio10,WorldClim_2.1_BCC-CSM2-MR_ssp126_10m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of warmest quarter,mean T of warmest qtr,year,degrees Celsius,*degree*C*, +bio11,bio11,WorldClim_2.1_BCC-CSM2-MR_ssp126_10m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of coldest quarter,mean T of coldest qtr,year,degrees Celsius,*degree*C*, +bio12,bio12,WorldClim_2.1_BCC-CSM2-MR_ssp126_10m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual precipitation,ann. P,year,mm per year,*mm~yr^-1*, +bio13,bio13,WorldClim_2.1_BCC-CSM2-MR_ssp126_10m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest month,P of wettest mo.,year,mm per month,*mm~mo^-1*, +bio14,bio14,WorldClim_2.1_BCC-CSM2-MR_ssp126_10m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest month,P of driest mo.,year,mm per month,*mm~mo^-1*, +bio15,bio15,WorldClim_2.1_BCC-CSM2-MR_ssp126_10m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation seasonality (coeff var),P season.,year,,, +bio16,bio16,WorldClim_2.1_BCC-CSM2-MR_ssp126_10m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest quarter,P of wettest qtr,year,mm per quarter,*mm~qtr^-1*, +bio17,bio17,WorldClim_2.1_BCC-CSM2-MR_ssp126_10m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest quarter,P of driest qtr,year,mm per quarter,*mm~qtr^-1*, +bio18,bio18,WorldClim_2.1_BCC-CSM2-MR_ssp126_10m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of warmest quarter,P of warmest qtr,year,mm per quarter,*mm~qtr^-1*, +bio19,bio19,WorldClim_2.1_BCC-CSM2-MR_ssp126_10m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of coldest quarter,P of coldest qtr,year,mm per quarter,*mm~qtr^-1*, +precipitation_01,precipitation_01,WorldClim_2.1_BCC-CSM2-MR_ssp126_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jan,P Jan,january,mm per month,*mm~mo^-1*, +precipitation_02,precipitation_02,WorldClim_2.1_BCC-CSM2-MR_ssp126_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Feb,P Feb,february,mm per month,*mm~mo^-1*, +precipitation_03,precipitation_03,WorldClim_2.1_BCC-CSM2-MR_ssp126_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Mar,P Mar,march,mm per month,*mm~mo^-1*, +precipitation_04,precipitation_04,WorldClim_2.1_BCC-CSM2-MR_ssp126_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Apr,P Apr,april,mm per month,*mm~mo^-1*, +precipitation_05,precipitation_05,WorldClim_2.1_BCC-CSM2-MR_ssp126_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation May,P May,may,mm per month,*mm~mo^-1*, +precipitation_06,precipitation_06,WorldClim_2.1_BCC-CSM2-MR_ssp126_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jun,P Jun,june,mm per month,*mm~mo^-1*, +precipitation_07,precipitation_07,WorldClim_2.1_BCC-CSM2-MR_ssp126_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jul,P Jul,july,mm per month,*mm~mo^-1*, +precipitation_08,precipitation_08,WorldClim_2.1_BCC-CSM2-MR_ssp126_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Aug,P Aug,august,mm per month,*mm~mo^-1*, +precipitation_09,precipitation_09,WorldClim_2.1_BCC-CSM2-MR_ssp126_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Sep,P Sep,september,mm per month,*mm~mo^-1*, +precipitation_10,precipitation_10,WorldClim_2.1_BCC-CSM2-MR_ssp126_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Oct,P Oct,october,mm per month,*mm~mo^-1*, +precipitation_11,precipitation_11,WorldClim_2.1_BCC-CSM2-MR_ssp126_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Nov,P Nov,november,mm per month,*mm~mo^-1*, +precipitation_12,precipitation_12,WorldClim_2.1_BCC-CSM2-MR_ssp126_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Dec,P Dec,december,mm per month,*mm~mo^-1*, +temperature_min_01,temperature_min_01,WorldClim_2.1_BCC-CSM2-MR_ssp126_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jan,min T Jan,january,degrees Celsius,*degree*C*, +temperature_min_02,temperature_min_02,WorldClim_2.1_BCC-CSM2-MR_ssp126_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Feb,min T Feb,february,degrees Celsius,*degree*C*, +temperature_min_03,temperature_min_03,WorldClim_2.1_BCC-CSM2-MR_ssp126_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Mar,min T Mar,march,degrees Celsius,*degree*C*, +temperature_min_04,temperature_min_04,WorldClim_2.1_BCC-CSM2-MR_ssp126_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Apr,min T Apr,april,degrees Celsius,*degree*C*, +temperature_min_05,temperature_min_05,WorldClim_2.1_BCC-CSM2-MR_ssp126_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature May,min T May,may,degrees Celsius,*degree*C*, +temperature_min_06,temperature_min_06,WorldClim_2.1_BCC-CSM2-MR_ssp126_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jun,min T Jun,june,degrees Celsius,*degree*C*, +temperature_min_07,temperature_min_07,WorldClim_2.1_BCC-CSM2-MR_ssp126_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jul,min T Jul,july,degrees Celsius,*degree*C*, +temperature_min_08,temperature_min_08,WorldClim_2.1_BCC-CSM2-MR_ssp126_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Aug,min T Aug,august,degrees Celsius,*degree*C*, +temperature_min_09,temperature_min_09,WorldClim_2.1_BCC-CSM2-MR_ssp126_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Sep,min T Sep,september,degrees Celsius,*degree*C*, +temperature_min_10,temperature_min_10,WorldClim_2.1_BCC-CSM2-MR_ssp126_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Oct,min T Oct,october,degrees Celsius,*degree*C*, +temperature_min_11,temperature_min_11,WorldClim_2.1_BCC-CSM2-MR_ssp126_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Nov,min T Nov,november,degrees Celsius,*degree*C*, +temperature_min_12,temperature_min_12,WorldClim_2.1_BCC-CSM2-MR_ssp126_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Dec,min T Dec,december,degrees Celsius,*degree*C*, +temperature_max_01,temperature_max_01,WorldClim_2.1_BCC-CSM2-MR_ssp126_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jan,max T Jan,january,degrees Celsius,*degree*C*, +temperature_max_02,temperature_max_02,WorldClim_2.1_BCC-CSM2-MR_ssp126_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Feb,max T Feb,february,degrees Celsius,*degree*C*, +temperature_max_03,temperature_max_03,WorldClim_2.1_BCC-CSM2-MR_ssp126_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Mar,max T Mar,march,degrees Celsius,*degree*C*, +temperature_max_04,temperature_max_04,WorldClim_2.1_BCC-CSM2-MR_ssp126_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Apr,max T Apr,april,degrees Celsius,*degree*C*, +temperature_max_05,temperature_max_05,WorldClim_2.1_BCC-CSM2-MR_ssp126_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature May,max T May,may,degrees Celsius,*degree*C*, +temperature_max_06,temperature_max_06,WorldClim_2.1_BCC-CSM2-MR_ssp126_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jun,max T Jun,june,degrees Celsius,*degree*C*, +temperature_max_07,temperature_max_07,WorldClim_2.1_BCC-CSM2-MR_ssp126_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jul,max T Jul,july,degrees Celsius,*degree*C*, +temperature_max_08,temperature_max_08,WorldClim_2.1_BCC-CSM2-MR_ssp126_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Aug,max T Aug,august,degrees Celsius,*degree*C*, +temperature_max_09,temperature_max_09,WorldClim_2.1_BCC-CSM2-MR_ssp126_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Sep,max T Sep,september,degrees Celsius,*degree*C*, +temperature_max_10,temperature_max_10,WorldClim_2.1_BCC-CSM2-MR_ssp126_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Oct,max T Oct,october,degrees Celsius,*degree*C*, +temperature_max_11,temperature_max_11,WorldClim_2.1_BCC-CSM2-MR_ssp126_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Nov,max T Nov,november,degrees Celsius,*degree*C*, +temperature_max_12,temperature_max_12,WorldClim_2.1_BCC-CSM2-MR_ssp126_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Dec,max T Dec,december,degrees Celsius,*degree*C*, +bio01,bio01,WorldClim_2.1_BCC-CSM2-MR_ssp126_5m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual mean temperature,ann. mean T,year,degrees Celsius,*degree*C*, +bio02,bio02,WorldClim_2.1_BCC-CSM2-MR_ssp126_5m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean diurnal range,diurn. range,year,degrees Celsius,*degree*C*, +bio03,bio03,WorldClim_2.1_BCC-CSM2-MR_ssp126_5m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,isothermality,isothermality,year,,, +bio04,bio04,WorldClim_2.1_BCC-CSM2-MR_ssp126_5m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature seasonality,T season.,year,degrees Celsius,*degree*C*, +bio05,bio05,WorldClim_2.1_BCC-CSM2-MR_ssp126_5m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature of warmest month,max. T of warmest mo.,year,degrees Celsius,*degree*C*, +bio06,bio06,WorldClim_2.1_BCC-CSM2-MR_ssp126_5m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature of coldest month,min. T of coldest mo.,year,degrees Celsius,*degree*C*, +bio07,bio07,WorldClim_2.1_BCC-CSM2-MR_ssp126_5m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature annual range (bio05-bio06),T ann. Range,year,degrees Celsius,*degree*C*, +bio08,bio08,WorldClim_2.1_BCC-CSM2-MR_ssp126_5m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of wettest quarter,mean T of wettest qtr,year,degrees Celsius,*degree*C*, +bio09,bio09,WorldClim_2.1_BCC-CSM2-MR_ssp126_5m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of driest quarter,mean T of driest qtr,year,degrees Celsius,*degree*C*, +bio10,bio10,WorldClim_2.1_BCC-CSM2-MR_ssp126_5m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of warmest quarter,mean T of warmest qtr,year,degrees Celsius,*degree*C*, +bio11,bio11,WorldClim_2.1_BCC-CSM2-MR_ssp126_5m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of coldest quarter,mean T of coldest qtr,year,degrees Celsius,*degree*C*, +bio12,bio12,WorldClim_2.1_BCC-CSM2-MR_ssp126_5m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual precipitation,ann. P,year,mm per year,*mm~yr^-1*, +bio13,bio13,WorldClim_2.1_BCC-CSM2-MR_ssp126_5m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest month,P of wettest mo.,year,mm per month,*mm~mo^-1*, +bio14,bio14,WorldClim_2.1_BCC-CSM2-MR_ssp126_5m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest month,P of driest mo.,year,mm per month,*mm~mo^-1*, +bio15,bio15,WorldClim_2.1_BCC-CSM2-MR_ssp126_5m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation seasonality (coeff var),P season.,year,,, +bio16,bio16,WorldClim_2.1_BCC-CSM2-MR_ssp126_5m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest quarter,P of wettest qtr,year,mm per quarter,*mm~qtr^-1*, +bio17,bio17,WorldClim_2.1_BCC-CSM2-MR_ssp126_5m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest quarter,P of driest qtr,year,mm per quarter,*mm~qtr^-1*, +bio18,bio18,WorldClim_2.1_BCC-CSM2-MR_ssp126_5m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of warmest quarter,P of warmest qtr,year,mm per quarter,*mm~qtr^-1*, +bio19,bio19,WorldClim_2.1_BCC-CSM2-MR_ssp126_5m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of coldest quarter,P of coldest qtr,year,mm per quarter,*mm~qtr^-1*, +precipitation_01,precipitation_01,WorldClim_2.1_BCC-CSM2-MR_ssp126_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jan,P Jan,january,mm per month,*mm~mo^-1*, +precipitation_02,precipitation_02,WorldClim_2.1_BCC-CSM2-MR_ssp126_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Feb,P Feb,february,mm per month,*mm~mo^-1*, +precipitation_03,precipitation_03,WorldClim_2.1_BCC-CSM2-MR_ssp126_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Mar,P Mar,march,mm per month,*mm~mo^-1*, +precipitation_04,precipitation_04,WorldClim_2.1_BCC-CSM2-MR_ssp126_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Apr,P Apr,april,mm per month,*mm~mo^-1*, +precipitation_05,precipitation_05,WorldClim_2.1_BCC-CSM2-MR_ssp126_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation May,P May,may,mm per month,*mm~mo^-1*, +precipitation_06,precipitation_06,WorldClim_2.1_BCC-CSM2-MR_ssp126_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jun,P Jun,june,mm per month,*mm~mo^-1*, +precipitation_07,precipitation_07,WorldClim_2.1_BCC-CSM2-MR_ssp126_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jul,P Jul,july,mm per month,*mm~mo^-1*, +precipitation_08,precipitation_08,WorldClim_2.1_BCC-CSM2-MR_ssp126_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Aug,P Aug,august,mm per month,*mm~mo^-1*, +precipitation_09,precipitation_09,WorldClim_2.1_BCC-CSM2-MR_ssp126_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Sep,P Sep,september,mm per month,*mm~mo^-1*, +precipitation_10,precipitation_10,WorldClim_2.1_BCC-CSM2-MR_ssp126_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Oct,P Oct,october,mm per month,*mm~mo^-1*, +precipitation_11,precipitation_11,WorldClim_2.1_BCC-CSM2-MR_ssp126_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Nov,P Nov,november,mm per month,*mm~mo^-1*, +precipitation_12,precipitation_12,WorldClim_2.1_BCC-CSM2-MR_ssp126_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Dec,P Dec,december,mm per month,*mm~mo^-1*, +temperature_min_01,temperature_min_01,WorldClim_2.1_BCC-CSM2-MR_ssp126_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jan,min T Jan,january,degrees Celsius,*degree*C*, +temperature_min_02,temperature_min_02,WorldClim_2.1_BCC-CSM2-MR_ssp126_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Feb,min T Feb,february,degrees Celsius,*degree*C*, +temperature_min_03,temperature_min_03,WorldClim_2.1_BCC-CSM2-MR_ssp126_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Mar,min T Mar,march,degrees Celsius,*degree*C*, +temperature_min_04,temperature_min_04,WorldClim_2.1_BCC-CSM2-MR_ssp126_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Apr,min T Apr,april,degrees Celsius,*degree*C*, +temperature_min_05,temperature_min_05,WorldClim_2.1_BCC-CSM2-MR_ssp126_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature May,min T May,may,degrees Celsius,*degree*C*, +temperature_min_06,temperature_min_06,WorldClim_2.1_BCC-CSM2-MR_ssp126_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jun,min T Jun,june,degrees Celsius,*degree*C*, +temperature_min_07,temperature_min_07,WorldClim_2.1_BCC-CSM2-MR_ssp126_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jul,min T Jul,july,degrees Celsius,*degree*C*, +temperature_min_08,temperature_min_08,WorldClim_2.1_BCC-CSM2-MR_ssp126_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Aug,min T Aug,august,degrees Celsius,*degree*C*, +temperature_min_09,temperature_min_09,WorldClim_2.1_BCC-CSM2-MR_ssp126_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Sep,min T Sep,september,degrees Celsius,*degree*C*, +temperature_min_10,temperature_min_10,WorldClim_2.1_BCC-CSM2-MR_ssp126_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Oct,min T Oct,october,degrees Celsius,*degree*C*, +temperature_min_11,temperature_min_11,WorldClim_2.1_BCC-CSM2-MR_ssp126_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Nov,min T Nov,november,degrees Celsius,*degree*C*, +temperature_min_12,temperature_min_12,WorldClim_2.1_BCC-CSM2-MR_ssp126_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Dec,min T Dec,december,degrees Celsius,*degree*C*, +temperature_max_01,temperature_max_01,WorldClim_2.1_BCC-CSM2-MR_ssp126_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jan,max T Jan,january,degrees Celsius,*degree*C*, +temperature_max_02,temperature_max_02,WorldClim_2.1_BCC-CSM2-MR_ssp126_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Feb,max T Feb,february,degrees Celsius,*degree*C*, +temperature_max_03,temperature_max_03,WorldClim_2.1_BCC-CSM2-MR_ssp126_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Mar,max T Mar,march,degrees Celsius,*degree*C*, +temperature_max_04,temperature_max_04,WorldClim_2.1_BCC-CSM2-MR_ssp126_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Apr,max T Apr,april,degrees Celsius,*degree*C*, +temperature_max_05,temperature_max_05,WorldClim_2.1_BCC-CSM2-MR_ssp126_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature May,max T May,may,degrees Celsius,*degree*C*, +temperature_max_06,temperature_max_06,WorldClim_2.1_BCC-CSM2-MR_ssp126_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jun,max T Jun,june,degrees Celsius,*degree*C*, +temperature_max_07,temperature_max_07,WorldClim_2.1_BCC-CSM2-MR_ssp126_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jul,max T Jul,july,degrees Celsius,*degree*C*, +temperature_max_08,temperature_max_08,WorldClim_2.1_BCC-CSM2-MR_ssp126_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Aug,max T Aug,august,degrees Celsius,*degree*C*, +temperature_max_09,temperature_max_09,WorldClim_2.1_BCC-CSM2-MR_ssp126_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Sep,max T Sep,september,degrees Celsius,*degree*C*, +temperature_max_10,temperature_max_10,WorldClim_2.1_BCC-CSM2-MR_ssp126_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Oct,max T Oct,october,degrees Celsius,*degree*C*, +temperature_max_11,temperature_max_11,WorldClim_2.1_BCC-CSM2-MR_ssp126_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Nov,max T Nov,november,degrees Celsius,*degree*C*, +temperature_max_12,temperature_max_12,WorldClim_2.1_BCC-CSM2-MR_ssp126_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Dec,max T Dec,december,degrees Celsius,*degree*C*, +bio01,bio01,WorldClim_2.1_BCC-CSM2-MR_ssp245_10m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual mean temperature,ann. mean T,year,degrees Celsius,*degree*C*, +bio02,bio02,WorldClim_2.1_BCC-CSM2-MR_ssp245_10m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean diurnal range,diurn. range,year,degrees Celsius,*degree*C*, +bio03,bio03,WorldClim_2.1_BCC-CSM2-MR_ssp245_10m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,isothermality,isothermality,year,,, +bio04,bio04,WorldClim_2.1_BCC-CSM2-MR_ssp245_10m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature seasonality,T season.,year,degrees Celsius,*degree*C*, +bio05,bio05,WorldClim_2.1_BCC-CSM2-MR_ssp245_10m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature of warmest month,max. T of warmest mo.,year,degrees Celsius,*degree*C*, +bio06,bio06,WorldClim_2.1_BCC-CSM2-MR_ssp245_10m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature of coldest month,min. T of coldest mo.,year,degrees Celsius,*degree*C*, +bio07,bio07,WorldClim_2.1_BCC-CSM2-MR_ssp245_10m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature annual range (bio05-bio06),T ann. Range,year,degrees Celsius,*degree*C*, +bio08,bio08,WorldClim_2.1_BCC-CSM2-MR_ssp245_10m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of wettest quarter,mean T of wettest qtr,year,degrees Celsius,*degree*C*, +bio09,bio09,WorldClim_2.1_BCC-CSM2-MR_ssp245_10m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of driest quarter,mean T of driest qtr,year,degrees Celsius,*degree*C*, +bio10,bio10,WorldClim_2.1_BCC-CSM2-MR_ssp245_10m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of warmest quarter,mean T of warmest qtr,year,degrees Celsius,*degree*C*, +bio11,bio11,WorldClim_2.1_BCC-CSM2-MR_ssp245_10m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of coldest quarter,mean T of coldest qtr,year,degrees Celsius,*degree*C*, +bio12,bio12,WorldClim_2.1_BCC-CSM2-MR_ssp245_10m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual precipitation,ann. P,year,mm per year,*mm~yr^-1*, +bio13,bio13,WorldClim_2.1_BCC-CSM2-MR_ssp245_10m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest month,P of wettest mo.,year,mm per month,*mm~mo^-1*, +bio14,bio14,WorldClim_2.1_BCC-CSM2-MR_ssp245_10m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest month,P of driest mo.,year,mm per month,*mm~mo^-1*, +bio15,bio15,WorldClim_2.1_BCC-CSM2-MR_ssp245_10m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation seasonality (coeff var),P season.,year,,, +bio16,bio16,WorldClim_2.1_BCC-CSM2-MR_ssp245_10m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest quarter,P of wettest qtr,year,mm per quarter,*mm~qtr^-1*, +bio17,bio17,WorldClim_2.1_BCC-CSM2-MR_ssp245_10m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest quarter,P of driest qtr,year,mm per quarter,*mm~qtr^-1*, +bio18,bio18,WorldClim_2.1_BCC-CSM2-MR_ssp245_10m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of warmest quarter,P of warmest qtr,year,mm per quarter,*mm~qtr^-1*, +bio19,bio19,WorldClim_2.1_BCC-CSM2-MR_ssp245_10m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of coldest quarter,P of coldest qtr,year,mm per quarter,*mm~qtr^-1*, +precipitation_01,precipitation_01,WorldClim_2.1_BCC-CSM2-MR_ssp245_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jan,P Jan,january,mm per month,*mm~mo^-1*, +precipitation_02,precipitation_02,WorldClim_2.1_BCC-CSM2-MR_ssp245_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Feb,P Feb,february,mm per month,*mm~mo^-1*, +precipitation_03,precipitation_03,WorldClim_2.1_BCC-CSM2-MR_ssp245_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Mar,P Mar,march,mm per month,*mm~mo^-1*, +precipitation_04,precipitation_04,WorldClim_2.1_BCC-CSM2-MR_ssp245_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Apr,P Apr,april,mm per month,*mm~mo^-1*, +precipitation_05,precipitation_05,WorldClim_2.1_BCC-CSM2-MR_ssp245_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation May,P May,may,mm per month,*mm~mo^-1*, +precipitation_06,precipitation_06,WorldClim_2.1_BCC-CSM2-MR_ssp245_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jun,P Jun,june,mm per month,*mm~mo^-1*, +precipitation_07,precipitation_07,WorldClim_2.1_BCC-CSM2-MR_ssp245_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jul,P Jul,july,mm per month,*mm~mo^-1*, +precipitation_08,precipitation_08,WorldClim_2.1_BCC-CSM2-MR_ssp245_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Aug,P Aug,august,mm per month,*mm~mo^-1*, +precipitation_09,precipitation_09,WorldClim_2.1_BCC-CSM2-MR_ssp245_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Sep,P Sep,september,mm per month,*mm~mo^-1*, +precipitation_10,precipitation_10,WorldClim_2.1_BCC-CSM2-MR_ssp245_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Oct,P Oct,october,mm per month,*mm~mo^-1*, +precipitation_11,precipitation_11,WorldClim_2.1_BCC-CSM2-MR_ssp245_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Nov,P Nov,november,mm per month,*mm~mo^-1*, +precipitation_12,precipitation_12,WorldClim_2.1_BCC-CSM2-MR_ssp245_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Dec,P Dec,december,mm per month,*mm~mo^-1*, +temperature_min_01,temperature_min_01,WorldClim_2.1_BCC-CSM2-MR_ssp245_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jan,min T Jan,january,degrees Celsius,*degree*C*, +temperature_min_02,temperature_min_02,WorldClim_2.1_BCC-CSM2-MR_ssp245_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Feb,min T Feb,february,degrees Celsius,*degree*C*, +temperature_min_03,temperature_min_03,WorldClim_2.1_BCC-CSM2-MR_ssp245_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Mar,min T Mar,march,degrees Celsius,*degree*C*, +temperature_min_04,temperature_min_04,WorldClim_2.1_BCC-CSM2-MR_ssp245_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Apr,min T Apr,april,degrees Celsius,*degree*C*, +temperature_min_05,temperature_min_05,WorldClim_2.1_BCC-CSM2-MR_ssp245_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature May,min T May,may,degrees Celsius,*degree*C*, +temperature_min_06,temperature_min_06,WorldClim_2.1_BCC-CSM2-MR_ssp245_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jun,min T Jun,june,degrees Celsius,*degree*C*, +temperature_min_07,temperature_min_07,WorldClim_2.1_BCC-CSM2-MR_ssp245_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jul,min T Jul,july,degrees Celsius,*degree*C*, +temperature_min_08,temperature_min_08,WorldClim_2.1_BCC-CSM2-MR_ssp245_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Aug,min T Aug,august,degrees Celsius,*degree*C*, +temperature_min_09,temperature_min_09,WorldClim_2.1_BCC-CSM2-MR_ssp245_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Sep,min T Sep,september,degrees Celsius,*degree*C*, +temperature_min_10,temperature_min_10,WorldClim_2.1_BCC-CSM2-MR_ssp245_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Oct,min T Oct,october,degrees Celsius,*degree*C*, +temperature_min_11,temperature_min_11,WorldClim_2.1_BCC-CSM2-MR_ssp245_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Nov,min T Nov,november,degrees Celsius,*degree*C*, +temperature_min_12,temperature_min_12,WorldClim_2.1_BCC-CSM2-MR_ssp245_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Dec,min T Dec,december,degrees Celsius,*degree*C*, +temperature_max_01,temperature_max_01,WorldClim_2.1_BCC-CSM2-MR_ssp245_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jan,max T Jan,january,degrees Celsius,*degree*C*, +temperature_max_02,temperature_max_02,WorldClim_2.1_BCC-CSM2-MR_ssp245_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Feb,max T Feb,february,degrees Celsius,*degree*C*, +temperature_max_03,temperature_max_03,WorldClim_2.1_BCC-CSM2-MR_ssp245_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Mar,max T Mar,march,degrees Celsius,*degree*C*, +temperature_max_04,temperature_max_04,WorldClim_2.1_BCC-CSM2-MR_ssp245_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Apr,max T Apr,april,degrees Celsius,*degree*C*, +temperature_max_05,temperature_max_05,WorldClim_2.1_BCC-CSM2-MR_ssp245_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature May,max T May,may,degrees Celsius,*degree*C*, +temperature_max_06,temperature_max_06,WorldClim_2.1_BCC-CSM2-MR_ssp245_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jun,max T Jun,june,degrees Celsius,*degree*C*, +temperature_max_07,temperature_max_07,WorldClim_2.1_BCC-CSM2-MR_ssp245_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jul,max T Jul,july,degrees Celsius,*degree*C*, +temperature_max_08,temperature_max_08,WorldClim_2.1_BCC-CSM2-MR_ssp245_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Aug,max T Aug,august,degrees Celsius,*degree*C*, +temperature_max_09,temperature_max_09,WorldClim_2.1_BCC-CSM2-MR_ssp245_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Sep,max T Sep,september,degrees Celsius,*degree*C*, +temperature_max_10,temperature_max_10,WorldClim_2.1_BCC-CSM2-MR_ssp245_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Oct,max T Oct,october,degrees Celsius,*degree*C*, +temperature_max_11,temperature_max_11,WorldClim_2.1_BCC-CSM2-MR_ssp245_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Nov,max T Nov,november,degrees Celsius,*degree*C*, +temperature_max_12,temperature_max_12,WorldClim_2.1_BCC-CSM2-MR_ssp245_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Dec,max T Dec,december,degrees Celsius,*degree*C*, +bio01,bio01,WorldClim_2.1_BCC-CSM2-MR_ssp245_5m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual mean temperature,ann. mean T,year,degrees Celsius,*degree*C*, +bio02,bio02,WorldClim_2.1_BCC-CSM2-MR_ssp245_5m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean diurnal range,diurn. range,year,degrees Celsius,*degree*C*, +bio03,bio03,WorldClim_2.1_BCC-CSM2-MR_ssp245_5m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,isothermality,isothermality,year,,, +bio04,bio04,WorldClim_2.1_BCC-CSM2-MR_ssp245_5m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature seasonality,T season.,year,degrees Celsius,*degree*C*, +bio05,bio05,WorldClim_2.1_BCC-CSM2-MR_ssp245_5m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature of warmest month,max. T of warmest mo.,year,degrees Celsius,*degree*C*, +bio06,bio06,WorldClim_2.1_BCC-CSM2-MR_ssp245_5m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature of coldest month,min. T of coldest mo.,year,degrees Celsius,*degree*C*, +bio07,bio07,WorldClim_2.1_BCC-CSM2-MR_ssp245_5m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature annual range (bio05-bio06),T ann. Range,year,degrees Celsius,*degree*C*, +bio08,bio08,WorldClim_2.1_BCC-CSM2-MR_ssp245_5m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of wettest quarter,mean T of wettest qtr,year,degrees Celsius,*degree*C*, +bio09,bio09,WorldClim_2.1_BCC-CSM2-MR_ssp245_5m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of driest quarter,mean T of driest qtr,year,degrees Celsius,*degree*C*, +bio10,bio10,WorldClim_2.1_BCC-CSM2-MR_ssp245_5m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of warmest quarter,mean T of warmest qtr,year,degrees Celsius,*degree*C*, +bio11,bio11,WorldClim_2.1_BCC-CSM2-MR_ssp245_5m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of coldest quarter,mean T of coldest qtr,year,degrees Celsius,*degree*C*, +bio12,bio12,WorldClim_2.1_BCC-CSM2-MR_ssp245_5m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual precipitation,ann. P,year,mm per year,*mm~yr^-1*, +bio13,bio13,WorldClim_2.1_BCC-CSM2-MR_ssp245_5m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest month,P of wettest mo.,year,mm per month,*mm~mo^-1*, +bio14,bio14,WorldClim_2.1_BCC-CSM2-MR_ssp245_5m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest month,P of driest mo.,year,mm per month,*mm~mo^-1*, +bio15,bio15,WorldClim_2.1_BCC-CSM2-MR_ssp245_5m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation seasonality (coeff var),P season.,year,,, +bio16,bio16,WorldClim_2.1_BCC-CSM2-MR_ssp245_5m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest quarter,P of wettest qtr,year,mm per quarter,*mm~qtr^-1*, +bio17,bio17,WorldClim_2.1_BCC-CSM2-MR_ssp245_5m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest quarter,P of driest qtr,year,mm per quarter,*mm~qtr^-1*, +bio18,bio18,WorldClim_2.1_BCC-CSM2-MR_ssp245_5m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of warmest quarter,P of warmest qtr,year,mm per quarter,*mm~qtr^-1*, +bio19,bio19,WorldClim_2.1_BCC-CSM2-MR_ssp245_5m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of coldest quarter,P of coldest qtr,year,mm per quarter,*mm~qtr^-1*, +precipitation_01,precipitation_01,WorldClim_2.1_BCC-CSM2-MR_ssp245_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jan,P Jan,january,mm per month,*mm~mo^-1*, +precipitation_02,precipitation_02,WorldClim_2.1_BCC-CSM2-MR_ssp245_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Feb,P Feb,february,mm per month,*mm~mo^-1*, +precipitation_03,precipitation_03,WorldClim_2.1_BCC-CSM2-MR_ssp245_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Mar,P Mar,march,mm per month,*mm~mo^-1*, +precipitation_04,precipitation_04,WorldClim_2.1_BCC-CSM2-MR_ssp245_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Apr,P Apr,april,mm per month,*mm~mo^-1*, +precipitation_05,precipitation_05,WorldClim_2.1_BCC-CSM2-MR_ssp245_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation May,P May,may,mm per month,*mm~mo^-1*, +precipitation_06,precipitation_06,WorldClim_2.1_BCC-CSM2-MR_ssp245_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jun,P Jun,june,mm per month,*mm~mo^-1*, +precipitation_07,precipitation_07,WorldClim_2.1_BCC-CSM2-MR_ssp245_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jul,P Jul,july,mm per month,*mm~mo^-1*, +precipitation_08,precipitation_08,WorldClim_2.1_BCC-CSM2-MR_ssp245_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Aug,P Aug,august,mm per month,*mm~mo^-1*, +precipitation_09,precipitation_09,WorldClim_2.1_BCC-CSM2-MR_ssp245_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Sep,P Sep,september,mm per month,*mm~mo^-1*, +precipitation_10,precipitation_10,WorldClim_2.1_BCC-CSM2-MR_ssp245_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Oct,P Oct,october,mm per month,*mm~mo^-1*, +precipitation_11,precipitation_11,WorldClim_2.1_BCC-CSM2-MR_ssp245_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Nov,P Nov,november,mm per month,*mm~mo^-1*, +precipitation_12,precipitation_12,WorldClim_2.1_BCC-CSM2-MR_ssp245_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Dec,P Dec,december,mm per month,*mm~mo^-1*, +temperature_min_01,temperature_min_01,WorldClim_2.1_BCC-CSM2-MR_ssp245_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jan,min T Jan,january,degrees Celsius,*degree*C*, +temperature_min_02,temperature_min_02,WorldClim_2.1_BCC-CSM2-MR_ssp245_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Feb,min T Feb,february,degrees Celsius,*degree*C*, +temperature_min_03,temperature_min_03,WorldClim_2.1_BCC-CSM2-MR_ssp245_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Mar,min T Mar,march,degrees Celsius,*degree*C*, +temperature_min_04,temperature_min_04,WorldClim_2.1_BCC-CSM2-MR_ssp245_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Apr,min T Apr,april,degrees Celsius,*degree*C*, +temperature_min_05,temperature_min_05,WorldClim_2.1_BCC-CSM2-MR_ssp245_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature May,min T May,may,degrees Celsius,*degree*C*, +temperature_min_06,temperature_min_06,WorldClim_2.1_BCC-CSM2-MR_ssp245_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jun,min T Jun,june,degrees Celsius,*degree*C*, +temperature_min_07,temperature_min_07,WorldClim_2.1_BCC-CSM2-MR_ssp245_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jul,min T Jul,july,degrees Celsius,*degree*C*, +temperature_min_08,temperature_min_08,WorldClim_2.1_BCC-CSM2-MR_ssp245_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Aug,min T Aug,august,degrees Celsius,*degree*C*, +temperature_min_09,temperature_min_09,WorldClim_2.1_BCC-CSM2-MR_ssp245_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Sep,min T Sep,september,degrees Celsius,*degree*C*, +temperature_min_10,temperature_min_10,WorldClim_2.1_BCC-CSM2-MR_ssp245_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Oct,min T Oct,october,degrees Celsius,*degree*C*, +temperature_min_11,temperature_min_11,WorldClim_2.1_BCC-CSM2-MR_ssp245_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Nov,min T Nov,november,degrees Celsius,*degree*C*, +temperature_min_12,temperature_min_12,WorldClim_2.1_BCC-CSM2-MR_ssp245_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Dec,min T Dec,december,degrees Celsius,*degree*C*, +temperature_max_01,temperature_max_01,WorldClim_2.1_BCC-CSM2-MR_ssp245_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jan,max T Jan,january,degrees Celsius,*degree*C*, +temperature_max_02,temperature_max_02,WorldClim_2.1_BCC-CSM2-MR_ssp245_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Feb,max T Feb,february,degrees Celsius,*degree*C*, +temperature_max_03,temperature_max_03,WorldClim_2.1_BCC-CSM2-MR_ssp245_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Mar,max T Mar,march,degrees Celsius,*degree*C*, +temperature_max_04,temperature_max_04,WorldClim_2.1_BCC-CSM2-MR_ssp245_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Apr,max T Apr,april,degrees Celsius,*degree*C*, +temperature_max_05,temperature_max_05,WorldClim_2.1_BCC-CSM2-MR_ssp245_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature May,max T May,may,degrees Celsius,*degree*C*, +temperature_max_06,temperature_max_06,WorldClim_2.1_BCC-CSM2-MR_ssp245_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jun,max T Jun,june,degrees Celsius,*degree*C*, +temperature_max_07,temperature_max_07,WorldClim_2.1_BCC-CSM2-MR_ssp245_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jul,max T Jul,july,degrees Celsius,*degree*C*, +temperature_max_08,temperature_max_08,WorldClim_2.1_BCC-CSM2-MR_ssp245_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Aug,max T Aug,august,degrees Celsius,*degree*C*, +temperature_max_09,temperature_max_09,WorldClim_2.1_BCC-CSM2-MR_ssp245_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Sep,max T Sep,september,degrees Celsius,*degree*C*, +temperature_max_10,temperature_max_10,WorldClim_2.1_BCC-CSM2-MR_ssp245_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Oct,max T Oct,october,degrees Celsius,*degree*C*, +temperature_max_11,temperature_max_11,WorldClim_2.1_BCC-CSM2-MR_ssp245_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Nov,max T Nov,november,degrees Celsius,*degree*C*, +temperature_max_12,temperature_max_12,WorldClim_2.1_BCC-CSM2-MR_ssp245_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Dec,max T Dec,december,degrees Celsius,*degree*C*, +bio01,bio01,WorldClim_2.1_BCC-CSM2-MR_ssp370_10m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual mean temperature,ann. mean T,year,degrees Celsius,*degree*C*, +bio02,bio02,WorldClim_2.1_BCC-CSM2-MR_ssp370_10m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean diurnal range,diurn. range,year,degrees Celsius,*degree*C*, +bio03,bio03,WorldClim_2.1_BCC-CSM2-MR_ssp370_10m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,isothermality,isothermality,year,,, +bio04,bio04,WorldClim_2.1_BCC-CSM2-MR_ssp370_10m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature seasonality,T season.,year,degrees Celsius,*degree*C*, +bio05,bio05,WorldClim_2.1_BCC-CSM2-MR_ssp370_10m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature of warmest month,max. T of warmest mo.,year,degrees Celsius,*degree*C*, +bio06,bio06,WorldClim_2.1_BCC-CSM2-MR_ssp370_10m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature of coldest month,min. T of coldest mo.,year,degrees Celsius,*degree*C*, +bio07,bio07,WorldClim_2.1_BCC-CSM2-MR_ssp370_10m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature annual range (bio05-bio06),T ann. Range,year,degrees Celsius,*degree*C*, +bio08,bio08,WorldClim_2.1_BCC-CSM2-MR_ssp370_10m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of wettest quarter,mean T of wettest qtr,year,degrees Celsius,*degree*C*, +bio09,bio09,WorldClim_2.1_BCC-CSM2-MR_ssp370_10m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of driest quarter,mean T of driest qtr,year,degrees Celsius,*degree*C*, +bio10,bio10,WorldClim_2.1_BCC-CSM2-MR_ssp370_10m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of warmest quarter,mean T of warmest qtr,year,degrees Celsius,*degree*C*, +bio11,bio11,WorldClim_2.1_BCC-CSM2-MR_ssp370_10m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of coldest quarter,mean T of coldest qtr,year,degrees Celsius,*degree*C*, +bio12,bio12,WorldClim_2.1_BCC-CSM2-MR_ssp370_10m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual precipitation,ann. P,year,mm per year,*mm~yr^-1*, +bio13,bio13,WorldClim_2.1_BCC-CSM2-MR_ssp370_10m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest month,P of wettest mo.,year,mm per month,*mm~mo^-1*, +bio14,bio14,WorldClim_2.1_BCC-CSM2-MR_ssp370_10m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest month,P of driest mo.,year,mm per month,*mm~mo^-1*, +bio15,bio15,WorldClim_2.1_BCC-CSM2-MR_ssp370_10m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation seasonality (coeff var),P season.,year,,, +bio16,bio16,WorldClim_2.1_BCC-CSM2-MR_ssp370_10m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest quarter,P of wettest qtr,year,mm per quarter,*mm~qtr^-1*, +bio17,bio17,WorldClim_2.1_BCC-CSM2-MR_ssp370_10m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest quarter,P of driest qtr,year,mm per quarter,*mm~qtr^-1*, +bio18,bio18,WorldClim_2.1_BCC-CSM2-MR_ssp370_10m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of warmest quarter,P of warmest qtr,year,mm per quarter,*mm~qtr^-1*, +bio19,bio19,WorldClim_2.1_BCC-CSM2-MR_ssp370_10m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of coldest quarter,P of coldest qtr,year,mm per quarter,*mm~qtr^-1*, +precipitation_01,precipitation_01,WorldClim_2.1_BCC-CSM2-MR_ssp370_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jan,P Jan,january,mm per month,*mm~mo^-1*, +precipitation_02,precipitation_02,WorldClim_2.1_BCC-CSM2-MR_ssp370_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Feb,P Feb,february,mm per month,*mm~mo^-1*, +precipitation_03,precipitation_03,WorldClim_2.1_BCC-CSM2-MR_ssp370_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Mar,P Mar,march,mm per month,*mm~mo^-1*, +precipitation_04,precipitation_04,WorldClim_2.1_BCC-CSM2-MR_ssp370_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Apr,P Apr,april,mm per month,*mm~mo^-1*, +precipitation_05,precipitation_05,WorldClim_2.1_BCC-CSM2-MR_ssp370_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation May,P May,may,mm per month,*mm~mo^-1*, +precipitation_06,precipitation_06,WorldClim_2.1_BCC-CSM2-MR_ssp370_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jun,P Jun,june,mm per month,*mm~mo^-1*, +precipitation_07,precipitation_07,WorldClim_2.1_BCC-CSM2-MR_ssp370_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jul,P Jul,july,mm per month,*mm~mo^-1*, +precipitation_08,precipitation_08,WorldClim_2.1_BCC-CSM2-MR_ssp370_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Aug,P Aug,august,mm per month,*mm~mo^-1*, +precipitation_09,precipitation_09,WorldClim_2.1_BCC-CSM2-MR_ssp370_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Sep,P Sep,september,mm per month,*mm~mo^-1*, +precipitation_10,precipitation_10,WorldClim_2.1_BCC-CSM2-MR_ssp370_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Oct,P Oct,october,mm per month,*mm~mo^-1*, +precipitation_11,precipitation_11,WorldClim_2.1_BCC-CSM2-MR_ssp370_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Nov,P Nov,november,mm per month,*mm~mo^-1*, +precipitation_12,precipitation_12,WorldClim_2.1_BCC-CSM2-MR_ssp370_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Dec,P Dec,december,mm per month,*mm~mo^-1*, +temperature_min_01,temperature_min_01,WorldClim_2.1_BCC-CSM2-MR_ssp370_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jan,min T Jan,january,degrees Celsius,*degree*C*, +temperature_min_02,temperature_min_02,WorldClim_2.1_BCC-CSM2-MR_ssp370_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Feb,min T Feb,february,degrees Celsius,*degree*C*, +temperature_min_03,temperature_min_03,WorldClim_2.1_BCC-CSM2-MR_ssp370_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Mar,min T Mar,march,degrees Celsius,*degree*C*, +temperature_min_04,temperature_min_04,WorldClim_2.1_BCC-CSM2-MR_ssp370_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Apr,min T Apr,april,degrees Celsius,*degree*C*, +temperature_min_05,temperature_min_05,WorldClim_2.1_BCC-CSM2-MR_ssp370_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature May,min T May,may,degrees Celsius,*degree*C*, +temperature_min_06,temperature_min_06,WorldClim_2.1_BCC-CSM2-MR_ssp370_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jun,min T Jun,june,degrees Celsius,*degree*C*, +temperature_min_07,temperature_min_07,WorldClim_2.1_BCC-CSM2-MR_ssp370_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jul,min T Jul,july,degrees Celsius,*degree*C*, +temperature_min_08,temperature_min_08,WorldClim_2.1_BCC-CSM2-MR_ssp370_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Aug,min T Aug,august,degrees Celsius,*degree*C*, +temperature_min_09,temperature_min_09,WorldClim_2.1_BCC-CSM2-MR_ssp370_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Sep,min T Sep,september,degrees Celsius,*degree*C*, +temperature_min_10,temperature_min_10,WorldClim_2.1_BCC-CSM2-MR_ssp370_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Oct,min T Oct,october,degrees Celsius,*degree*C*, +temperature_min_11,temperature_min_11,WorldClim_2.1_BCC-CSM2-MR_ssp370_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Nov,min T Nov,november,degrees Celsius,*degree*C*, +temperature_min_12,temperature_min_12,WorldClim_2.1_BCC-CSM2-MR_ssp370_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Dec,min T Dec,december,degrees Celsius,*degree*C*, +temperature_max_01,temperature_max_01,WorldClim_2.1_BCC-CSM2-MR_ssp370_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jan,max T Jan,january,degrees Celsius,*degree*C*, +temperature_max_02,temperature_max_02,WorldClim_2.1_BCC-CSM2-MR_ssp370_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Feb,max T Feb,february,degrees Celsius,*degree*C*, +temperature_max_03,temperature_max_03,WorldClim_2.1_BCC-CSM2-MR_ssp370_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Mar,max T Mar,march,degrees Celsius,*degree*C*, +temperature_max_04,temperature_max_04,WorldClim_2.1_BCC-CSM2-MR_ssp370_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Apr,max T Apr,april,degrees Celsius,*degree*C*, +temperature_max_05,temperature_max_05,WorldClim_2.1_BCC-CSM2-MR_ssp370_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature May,max T May,may,degrees Celsius,*degree*C*, +temperature_max_06,temperature_max_06,WorldClim_2.1_BCC-CSM2-MR_ssp370_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jun,max T Jun,june,degrees Celsius,*degree*C*, +temperature_max_07,temperature_max_07,WorldClim_2.1_BCC-CSM2-MR_ssp370_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jul,max T Jul,july,degrees Celsius,*degree*C*, +temperature_max_08,temperature_max_08,WorldClim_2.1_BCC-CSM2-MR_ssp370_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Aug,max T Aug,august,degrees Celsius,*degree*C*, +temperature_max_09,temperature_max_09,WorldClim_2.1_BCC-CSM2-MR_ssp370_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Sep,max T Sep,september,degrees Celsius,*degree*C*, +temperature_max_10,temperature_max_10,WorldClim_2.1_BCC-CSM2-MR_ssp370_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Oct,max T Oct,october,degrees Celsius,*degree*C*, +temperature_max_11,temperature_max_11,WorldClim_2.1_BCC-CSM2-MR_ssp370_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Nov,max T Nov,november,degrees Celsius,*degree*C*, +temperature_max_12,temperature_max_12,WorldClim_2.1_BCC-CSM2-MR_ssp370_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Dec,max T Dec,december,degrees Celsius,*degree*C*, +bio01,bio01,WorldClim_2.1_BCC-CSM2-MR_ssp370_5m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual mean temperature,ann. mean T,year,degrees Celsius,*degree*C*, +bio02,bio02,WorldClim_2.1_BCC-CSM2-MR_ssp370_5m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean diurnal range,diurn. range,year,degrees Celsius,*degree*C*, +bio03,bio03,WorldClim_2.1_BCC-CSM2-MR_ssp370_5m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,isothermality,isothermality,year,,, +bio04,bio04,WorldClim_2.1_BCC-CSM2-MR_ssp370_5m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature seasonality,T season.,year,degrees Celsius,*degree*C*, +bio05,bio05,WorldClim_2.1_BCC-CSM2-MR_ssp370_5m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature of warmest month,max. T of warmest mo.,year,degrees Celsius,*degree*C*, +bio06,bio06,WorldClim_2.1_BCC-CSM2-MR_ssp370_5m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature of coldest month,min. T of coldest mo.,year,degrees Celsius,*degree*C*, +bio07,bio07,WorldClim_2.1_BCC-CSM2-MR_ssp370_5m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature annual range (bio05-bio06),T ann. Range,year,degrees Celsius,*degree*C*, +bio08,bio08,WorldClim_2.1_BCC-CSM2-MR_ssp370_5m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of wettest quarter,mean T of wettest qtr,year,degrees Celsius,*degree*C*, +bio09,bio09,WorldClim_2.1_BCC-CSM2-MR_ssp370_5m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of driest quarter,mean T of driest qtr,year,degrees Celsius,*degree*C*, +bio10,bio10,WorldClim_2.1_BCC-CSM2-MR_ssp370_5m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of warmest quarter,mean T of warmest qtr,year,degrees Celsius,*degree*C*, +bio11,bio11,WorldClim_2.1_BCC-CSM2-MR_ssp370_5m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of coldest quarter,mean T of coldest qtr,year,degrees Celsius,*degree*C*, +bio12,bio12,WorldClim_2.1_BCC-CSM2-MR_ssp370_5m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual precipitation,ann. P,year,mm per year,*mm~yr^-1*, +bio13,bio13,WorldClim_2.1_BCC-CSM2-MR_ssp370_5m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest month,P of wettest mo.,year,mm per month,*mm~mo^-1*, +bio14,bio14,WorldClim_2.1_BCC-CSM2-MR_ssp370_5m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest month,P of driest mo.,year,mm per month,*mm~mo^-1*, +bio15,bio15,WorldClim_2.1_BCC-CSM2-MR_ssp370_5m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation seasonality (coeff var),P season.,year,,, +bio16,bio16,WorldClim_2.1_BCC-CSM2-MR_ssp370_5m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest quarter,P of wettest qtr,year,mm per quarter,*mm~qtr^-1*, +bio17,bio17,WorldClim_2.1_BCC-CSM2-MR_ssp370_5m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest quarter,P of driest qtr,year,mm per quarter,*mm~qtr^-1*, +bio18,bio18,WorldClim_2.1_BCC-CSM2-MR_ssp370_5m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of warmest quarter,P of warmest qtr,year,mm per quarter,*mm~qtr^-1*, +bio19,bio19,WorldClim_2.1_BCC-CSM2-MR_ssp370_5m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of coldest quarter,P of coldest qtr,year,mm per quarter,*mm~qtr^-1*, +precipitation_01,precipitation_01,WorldClim_2.1_BCC-CSM2-MR_ssp370_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jan,P Jan,january,mm per month,*mm~mo^-1*, +precipitation_02,precipitation_02,WorldClim_2.1_BCC-CSM2-MR_ssp370_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Feb,P Feb,february,mm per month,*mm~mo^-1*, +precipitation_03,precipitation_03,WorldClim_2.1_BCC-CSM2-MR_ssp370_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Mar,P Mar,march,mm per month,*mm~mo^-1*, +precipitation_04,precipitation_04,WorldClim_2.1_BCC-CSM2-MR_ssp370_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Apr,P Apr,april,mm per month,*mm~mo^-1*, +precipitation_05,precipitation_05,WorldClim_2.1_BCC-CSM2-MR_ssp370_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation May,P May,may,mm per month,*mm~mo^-1*, +precipitation_06,precipitation_06,WorldClim_2.1_BCC-CSM2-MR_ssp370_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jun,P Jun,june,mm per month,*mm~mo^-1*, +precipitation_07,precipitation_07,WorldClim_2.1_BCC-CSM2-MR_ssp370_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jul,P Jul,july,mm per month,*mm~mo^-1*, +precipitation_08,precipitation_08,WorldClim_2.1_BCC-CSM2-MR_ssp370_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Aug,P Aug,august,mm per month,*mm~mo^-1*, +precipitation_09,precipitation_09,WorldClim_2.1_BCC-CSM2-MR_ssp370_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Sep,P Sep,september,mm per month,*mm~mo^-1*, +precipitation_10,precipitation_10,WorldClim_2.1_BCC-CSM2-MR_ssp370_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Oct,P Oct,october,mm per month,*mm~mo^-1*, +precipitation_11,precipitation_11,WorldClim_2.1_BCC-CSM2-MR_ssp370_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Nov,P Nov,november,mm per month,*mm~mo^-1*, +precipitation_12,precipitation_12,WorldClim_2.1_BCC-CSM2-MR_ssp370_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Dec,P Dec,december,mm per month,*mm~mo^-1*, +temperature_min_01,temperature_min_01,WorldClim_2.1_BCC-CSM2-MR_ssp370_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jan,min T Jan,january,degrees Celsius,*degree*C*, +temperature_min_02,temperature_min_02,WorldClim_2.1_BCC-CSM2-MR_ssp370_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Feb,min T Feb,february,degrees Celsius,*degree*C*, +temperature_min_03,temperature_min_03,WorldClim_2.1_BCC-CSM2-MR_ssp370_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Mar,min T Mar,march,degrees Celsius,*degree*C*, +temperature_min_04,temperature_min_04,WorldClim_2.1_BCC-CSM2-MR_ssp370_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Apr,min T Apr,april,degrees Celsius,*degree*C*, +temperature_min_05,temperature_min_05,WorldClim_2.1_BCC-CSM2-MR_ssp370_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature May,min T May,may,degrees Celsius,*degree*C*, +temperature_min_06,temperature_min_06,WorldClim_2.1_BCC-CSM2-MR_ssp370_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jun,min T Jun,june,degrees Celsius,*degree*C*, +temperature_min_07,temperature_min_07,WorldClim_2.1_BCC-CSM2-MR_ssp370_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jul,min T Jul,july,degrees Celsius,*degree*C*, +temperature_min_08,temperature_min_08,WorldClim_2.1_BCC-CSM2-MR_ssp370_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Aug,min T Aug,august,degrees Celsius,*degree*C*, +temperature_min_09,temperature_min_09,WorldClim_2.1_BCC-CSM2-MR_ssp370_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Sep,min T Sep,september,degrees Celsius,*degree*C*, +temperature_min_10,temperature_min_10,WorldClim_2.1_BCC-CSM2-MR_ssp370_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Oct,min T Oct,october,degrees Celsius,*degree*C*, +temperature_min_11,temperature_min_11,WorldClim_2.1_BCC-CSM2-MR_ssp370_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Nov,min T Nov,november,degrees Celsius,*degree*C*, +temperature_min_12,temperature_min_12,WorldClim_2.1_BCC-CSM2-MR_ssp370_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Dec,min T Dec,december,degrees Celsius,*degree*C*, +temperature_max_01,temperature_max_01,WorldClim_2.1_BCC-CSM2-MR_ssp370_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jan,max T Jan,january,degrees Celsius,*degree*C*, +temperature_max_02,temperature_max_02,WorldClim_2.1_BCC-CSM2-MR_ssp370_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Feb,max T Feb,february,degrees Celsius,*degree*C*, +temperature_max_03,temperature_max_03,WorldClim_2.1_BCC-CSM2-MR_ssp370_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Mar,max T Mar,march,degrees Celsius,*degree*C*, +temperature_max_04,temperature_max_04,WorldClim_2.1_BCC-CSM2-MR_ssp370_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Apr,max T Apr,april,degrees Celsius,*degree*C*, +temperature_max_05,temperature_max_05,WorldClim_2.1_BCC-CSM2-MR_ssp370_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature May,max T May,may,degrees Celsius,*degree*C*, +temperature_max_06,temperature_max_06,WorldClim_2.1_BCC-CSM2-MR_ssp370_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jun,max T Jun,june,degrees Celsius,*degree*C*, +temperature_max_07,temperature_max_07,WorldClim_2.1_BCC-CSM2-MR_ssp370_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jul,max T Jul,july,degrees Celsius,*degree*C*, +temperature_max_08,temperature_max_08,WorldClim_2.1_BCC-CSM2-MR_ssp370_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Aug,max T Aug,august,degrees Celsius,*degree*C*, +temperature_max_09,temperature_max_09,WorldClim_2.1_BCC-CSM2-MR_ssp370_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Sep,max T Sep,september,degrees Celsius,*degree*C*, +temperature_max_10,temperature_max_10,WorldClim_2.1_BCC-CSM2-MR_ssp370_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Oct,max T Oct,october,degrees Celsius,*degree*C*, +temperature_max_11,temperature_max_11,WorldClim_2.1_BCC-CSM2-MR_ssp370_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Nov,max T Nov,november,degrees Celsius,*degree*C*, +temperature_max_12,temperature_max_12,WorldClim_2.1_BCC-CSM2-MR_ssp370_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Dec,max T Dec,december,degrees Celsius,*degree*C*, +bio01,bio01,WorldClim_2.1_BCC-CSM2-MR_ssp585_10m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual mean temperature,ann. mean T,year,degrees Celsius,*degree*C*, +bio02,bio02,WorldClim_2.1_BCC-CSM2-MR_ssp585_10m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean diurnal range,diurn. range,year,degrees Celsius,*degree*C*, +bio03,bio03,WorldClim_2.1_BCC-CSM2-MR_ssp585_10m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,isothermality,isothermality,year,,, +bio04,bio04,WorldClim_2.1_BCC-CSM2-MR_ssp585_10m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature seasonality,T season.,year,degrees Celsius,*degree*C*, +bio05,bio05,WorldClim_2.1_BCC-CSM2-MR_ssp585_10m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature of warmest month,max. T of warmest mo.,year,degrees Celsius,*degree*C*, +bio06,bio06,WorldClim_2.1_BCC-CSM2-MR_ssp585_10m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature of coldest month,min. T of coldest mo.,year,degrees Celsius,*degree*C*, +bio07,bio07,WorldClim_2.1_BCC-CSM2-MR_ssp585_10m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature annual range (bio05-bio06),T ann. Range,year,degrees Celsius,*degree*C*, +bio08,bio08,WorldClim_2.1_BCC-CSM2-MR_ssp585_10m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of wettest quarter,mean T of wettest qtr,year,degrees Celsius,*degree*C*, +bio09,bio09,WorldClim_2.1_BCC-CSM2-MR_ssp585_10m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of driest quarter,mean T of driest qtr,year,degrees Celsius,*degree*C*, +bio10,bio10,WorldClim_2.1_BCC-CSM2-MR_ssp585_10m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of warmest quarter,mean T of warmest qtr,year,degrees Celsius,*degree*C*, +bio11,bio11,WorldClim_2.1_BCC-CSM2-MR_ssp585_10m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of coldest quarter,mean T of coldest qtr,year,degrees Celsius,*degree*C*, +bio12,bio12,WorldClim_2.1_BCC-CSM2-MR_ssp585_10m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual precipitation,ann. P,year,mm per year,*mm~yr^-1*, +bio13,bio13,WorldClim_2.1_BCC-CSM2-MR_ssp585_10m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest month,P of wettest mo.,year,mm per month,*mm~mo^-1*, +bio14,bio14,WorldClim_2.1_BCC-CSM2-MR_ssp585_10m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest month,P of driest mo.,year,mm per month,*mm~mo^-1*, +bio15,bio15,WorldClim_2.1_BCC-CSM2-MR_ssp585_10m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation seasonality (coeff var),P season.,year,,, +bio16,bio16,WorldClim_2.1_BCC-CSM2-MR_ssp585_10m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest quarter,P of wettest qtr,year,mm per quarter,*mm~qtr^-1*, +bio17,bio17,WorldClim_2.1_BCC-CSM2-MR_ssp585_10m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest quarter,P of driest qtr,year,mm per quarter,*mm~qtr^-1*, +bio18,bio18,WorldClim_2.1_BCC-CSM2-MR_ssp585_10m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of warmest quarter,P of warmest qtr,year,mm per quarter,*mm~qtr^-1*, +bio19,bio19,WorldClim_2.1_BCC-CSM2-MR_ssp585_10m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of coldest quarter,P of coldest qtr,year,mm per quarter,*mm~qtr^-1*, +precipitation_01,precipitation_01,WorldClim_2.1_BCC-CSM2-MR_ssp585_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jan,P Jan,january,mm per month,*mm~mo^-1*, +precipitation_02,precipitation_02,WorldClim_2.1_BCC-CSM2-MR_ssp585_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Feb,P Feb,february,mm per month,*mm~mo^-1*, +precipitation_03,precipitation_03,WorldClim_2.1_BCC-CSM2-MR_ssp585_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Mar,P Mar,march,mm per month,*mm~mo^-1*, +precipitation_04,precipitation_04,WorldClim_2.1_BCC-CSM2-MR_ssp585_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Apr,P Apr,april,mm per month,*mm~mo^-1*, +precipitation_05,precipitation_05,WorldClim_2.1_BCC-CSM2-MR_ssp585_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation May,P May,may,mm per month,*mm~mo^-1*, +precipitation_06,precipitation_06,WorldClim_2.1_BCC-CSM2-MR_ssp585_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jun,P Jun,june,mm per month,*mm~mo^-1*, +precipitation_07,precipitation_07,WorldClim_2.1_BCC-CSM2-MR_ssp585_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jul,P Jul,july,mm per month,*mm~mo^-1*, +precipitation_08,precipitation_08,WorldClim_2.1_BCC-CSM2-MR_ssp585_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Aug,P Aug,august,mm per month,*mm~mo^-1*, +precipitation_09,precipitation_09,WorldClim_2.1_BCC-CSM2-MR_ssp585_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Sep,P Sep,september,mm per month,*mm~mo^-1*, +precipitation_10,precipitation_10,WorldClim_2.1_BCC-CSM2-MR_ssp585_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Oct,P Oct,october,mm per month,*mm~mo^-1*, +precipitation_11,precipitation_11,WorldClim_2.1_BCC-CSM2-MR_ssp585_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Nov,P Nov,november,mm per month,*mm~mo^-1*, +precipitation_12,precipitation_12,WorldClim_2.1_BCC-CSM2-MR_ssp585_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Dec,P Dec,december,mm per month,*mm~mo^-1*, +temperature_min_01,temperature_min_01,WorldClim_2.1_BCC-CSM2-MR_ssp585_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jan,min T Jan,january,degrees Celsius,*degree*C*, +temperature_min_02,temperature_min_02,WorldClim_2.1_BCC-CSM2-MR_ssp585_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Feb,min T Feb,february,degrees Celsius,*degree*C*, +temperature_min_03,temperature_min_03,WorldClim_2.1_BCC-CSM2-MR_ssp585_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Mar,min T Mar,march,degrees Celsius,*degree*C*, +temperature_min_04,temperature_min_04,WorldClim_2.1_BCC-CSM2-MR_ssp585_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Apr,min T Apr,april,degrees Celsius,*degree*C*, +temperature_min_05,temperature_min_05,WorldClim_2.1_BCC-CSM2-MR_ssp585_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature May,min T May,may,degrees Celsius,*degree*C*, +temperature_min_06,temperature_min_06,WorldClim_2.1_BCC-CSM2-MR_ssp585_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jun,min T Jun,june,degrees Celsius,*degree*C*, +temperature_min_07,temperature_min_07,WorldClim_2.1_BCC-CSM2-MR_ssp585_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jul,min T Jul,july,degrees Celsius,*degree*C*, +temperature_min_08,temperature_min_08,WorldClim_2.1_BCC-CSM2-MR_ssp585_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Aug,min T Aug,august,degrees Celsius,*degree*C*, +temperature_min_09,temperature_min_09,WorldClim_2.1_BCC-CSM2-MR_ssp585_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Sep,min T Sep,september,degrees Celsius,*degree*C*, +temperature_min_10,temperature_min_10,WorldClim_2.1_BCC-CSM2-MR_ssp585_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Oct,min T Oct,october,degrees Celsius,*degree*C*, +temperature_min_11,temperature_min_11,WorldClim_2.1_BCC-CSM2-MR_ssp585_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Nov,min T Nov,november,degrees Celsius,*degree*C*, +temperature_min_12,temperature_min_12,WorldClim_2.1_BCC-CSM2-MR_ssp585_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Dec,min T Dec,december,degrees Celsius,*degree*C*, +temperature_max_01,temperature_max_01,WorldClim_2.1_BCC-CSM2-MR_ssp585_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jan,max T Jan,january,degrees Celsius,*degree*C*, +temperature_max_02,temperature_max_02,WorldClim_2.1_BCC-CSM2-MR_ssp585_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Feb,max T Feb,february,degrees Celsius,*degree*C*, +temperature_max_03,temperature_max_03,WorldClim_2.1_BCC-CSM2-MR_ssp585_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Mar,max T Mar,march,degrees Celsius,*degree*C*, +temperature_max_04,temperature_max_04,WorldClim_2.1_BCC-CSM2-MR_ssp585_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Apr,max T Apr,april,degrees Celsius,*degree*C*, +temperature_max_05,temperature_max_05,WorldClim_2.1_BCC-CSM2-MR_ssp585_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature May,max T May,may,degrees Celsius,*degree*C*, +temperature_max_06,temperature_max_06,WorldClim_2.1_BCC-CSM2-MR_ssp585_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jun,max T Jun,june,degrees Celsius,*degree*C*, +temperature_max_07,temperature_max_07,WorldClim_2.1_BCC-CSM2-MR_ssp585_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jul,max T Jul,july,degrees Celsius,*degree*C*, +temperature_max_08,temperature_max_08,WorldClim_2.1_BCC-CSM2-MR_ssp585_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Aug,max T Aug,august,degrees Celsius,*degree*C*, +temperature_max_09,temperature_max_09,WorldClim_2.1_BCC-CSM2-MR_ssp585_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Sep,max T Sep,september,degrees Celsius,*degree*C*, +temperature_max_10,temperature_max_10,WorldClim_2.1_BCC-CSM2-MR_ssp585_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Oct,max T Oct,october,degrees Celsius,*degree*C*, +temperature_max_11,temperature_max_11,WorldClim_2.1_BCC-CSM2-MR_ssp585_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Nov,max T Nov,november,degrees Celsius,*degree*C*, +temperature_max_12,temperature_max_12,WorldClim_2.1_BCC-CSM2-MR_ssp585_10m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Dec,max T Dec,december,degrees Celsius,*degree*C*, +bio01,bio01,WorldClim_2.1_BCC-CSM2-MR_ssp585_5m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual mean temperature,ann. mean T,year,degrees Celsius,*degree*C*, +bio02,bio02,WorldClim_2.1_BCC-CSM2-MR_ssp585_5m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean diurnal range,diurn. range,year,degrees Celsius,*degree*C*, +bio03,bio03,WorldClim_2.1_BCC-CSM2-MR_ssp585_5m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,isothermality,isothermality,year,,, +bio04,bio04,WorldClim_2.1_BCC-CSM2-MR_ssp585_5m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature seasonality,T season.,year,degrees Celsius,*degree*C*, +bio05,bio05,WorldClim_2.1_BCC-CSM2-MR_ssp585_5m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature of warmest month,max. T of warmest mo.,year,degrees Celsius,*degree*C*, +bio06,bio06,WorldClim_2.1_BCC-CSM2-MR_ssp585_5m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature of coldest month,min. T of coldest mo.,year,degrees Celsius,*degree*C*, +bio07,bio07,WorldClim_2.1_BCC-CSM2-MR_ssp585_5m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature annual range (bio05-bio06),T ann. Range,year,degrees Celsius,*degree*C*, +bio08,bio08,WorldClim_2.1_BCC-CSM2-MR_ssp585_5m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of wettest quarter,mean T of wettest qtr,year,degrees Celsius,*degree*C*, +bio09,bio09,WorldClim_2.1_BCC-CSM2-MR_ssp585_5m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of driest quarter,mean T of driest qtr,year,degrees Celsius,*degree*C*, +bio10,bio10,WorldClim_2.1_BCC-CSM2-MR_ssp585_5m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of warmest quarter,mean T of warmest qtr,year,degrees Celsius,*degree*C*, +bio11,bio11,WorldClim_2.1_BCC-CSM2-MR_ssp585_5m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of coldest quarter,mean T of coldest qtr,year,degrees Celsius,*degree*C*, +bio12,bio12,WorldClim_2.1_BCC-CSM2-MR_ssp585_5m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual precipitation,ann. P,year,mm per year,*mm~yr^-1*, +bio13,bio13,WorldClim_2.1_BCC-CSM2-MR_ssp585_5m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest month,P of wettest mo.,year,mm per month,*mm~mo^-1*, +bio14,bio14,WorldClim_2.1_BCC-CSM2-MR_ssp585_5m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest month,P of driest mo.,year,mm per month,*mm~mo^-1*, +bio15,bio15,WorldClim_2.1_BCC-CSM2-MR_ssp585_5m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation seasonality (coeff var),P season.,year,,, +bio16,bio16,WorldClim_2.1_BCC-CSM2-MR_ssp585_5m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest quarter,P of wettest qtr,year,mm per quarter,*mm~qtr^-1*, +bio17,bio17,WorldClim_2.1_BCC-CSM2-MR_ssp585_5m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest quarter,P of driest qtr,year,mm per quarter,*mm~qtr^-1*, +bio18,bio18,WorldClim_2.1_BCC-CSM2-MR_ssp585_5m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of warmest quarter,P of warmest qtr,year,mm per quarter,*mm~qtr^-1*, +bio19,bio19,WorldClim_2.1_BCC-CSM2-MR_ssp585_5m,FALSE,WorldClim_2.1_BCC-CSM2-MR_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of coldest quarter,P of coldest qtr,year,mm per quarter,*mm~qtr^-1*, +precipitation_01,precipitation_01,WorldClim_2.1_BCC-CSM2-MR_ssp585_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jan,P Jan,january,mm per month,*mm~mo^-1*, +precipitation_02,precipitation_02,WorldClim_2.1_BCC-CSM2-MR_ssp585_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Feb,P Feb,february,mm per month,*mm~mo^-1*, +precipitation_03,precipitation_03,WorldClim_2.1_BCC-CSM2-MR_ssp585_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Mar,P Mar,march,mm per month,*mm~mo^-1*, +precipitation_04,precipitation_04,WorldClim_2.1_BCC-CSM2-MR_ssp585_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Apr,P Apr,april,mm per month,*mm~mo^-1*, +precipitation_05,precipitation_05,WorldClim_2.1_BCC-CSM2-MR_ssp585_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation May,P May,may,mm per month,*mm~mo^-1*, +precipitation_06,precipitation_06,WorldClim_2.1_BCC-CSM2-MR_ssp585_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jun,P Jun,june,mm per month,*mm~mo^-1*, +precipitation_07,precipitation_07,WorldClim_2.1_BCC-CSM2-MR_ssp585_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jul,P Jul,july,mm per month,*mm~mo^-1*, +precipitation_08,precipitation_08,WorldClim_2.1_BCC-CSM2-MR_ssp585_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Aug,P Aug,august,mm per month,*mm~mo^-1*, +precipitation_09,precipitation_09,WorldClim_2.1_BCC-CSM2-MR_ssp585_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Sep,P Sep,september,mm per month,*mm~mo^-1*, +precipitation_10,precipitation_10,WorldClim_2.1_BCC-CSM2-MR_ssp585_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Oct,P Oct,october,mm per month,*mm~mo^-1*, +precipitation_11,precipitation_11,WorldClim_2.1_BCC-CSM2-MR_ssp585_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Nov,P Nov,november,mm per month,*mm~mo^-1*, +precipitation_12,precipitation_12,WorldClim_2.1_BCC-CSM2-MR_ssp585_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Dec,P Dec,december,mm per month,*mm~mo^-1*, +temperature_min_01,temperature_min_01,WorldClim_2.1_BCC-CSM2-MR_ssp585_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jan,min T Jan,january,degrees Celsius,*degree*C*, +temperature_min_02,temperature_min_02,WorldClim_2.1_BCC-CSM2-MR_ssp585_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Feb,min T Feb,february,degrees Celsius,*degree*C*, +temperature_min_03,temperature_min_03,WorldClim_2.1_BCC-CSM2-MR_ssp585_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Mar,min T Mar,march,degrees Celsius,*degree*C*, +temperature_min_04,temperature_min_04,WorldClim_2.1_BCC-CSM2-MR_ssp585_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Apr,min T Apr,april,degrees Celsius,*degree*C*, +temperature_min_05,temperature_min_05,WorldClim_2.1_BCC-CSM2-MR_ssp585_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature May,min T May,may,degrees Celsius,*degree*C*, +temperature_min_06,temperature_min_06,WorldClim_2.1_BCC-CSM2-MR_ssp585_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jun,min T Jun,june,degrees Celsius,*degree*C*, +temperature_min_07,temperature_min_07,WorldClim_2.1_BCC-CSM2-MR_ssp585_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jul,min T Jul,july,degrees Celsius,*degree*C*, +temperature_min_08,temperature_min_08,WorldClim_2.1_BCC-CSM2-MR_ssp585_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Aug,min T Aug,august,degrees Celsius,*degree*C*, +temperature_min_09,temperature_min_09,WorldClim_2.1_BCC-CSM2-MR_ssp585_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Sep,min T Sep,september,degrees Celsius,*degree*C*, +temperature_min_10,temperature_min_10,WorldClim_2.1_BCC-CSM2-MR_ssp585_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Oct,min T Oct,october,degrees Celsius,*degree*C*, +temperature_min_11,temperature_min_11,WorldClim_2.1_BCC-CSM2-MR_ssp585_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Nov,min T Nov,november,degrees Celsius,*degree*C*, +temperature_min_12,temperature_min_12,WorldClim_2.1_BCC-CSM2-MR_ssp585_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Dec,min T Dec,december,degrees Celsius,*degree*C*, +temperature_max_01,temperature_max_01,WorldClim_2.1_BCC-CSM2-MR_ssp585_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jan,max T Jan,january,degrees Celsius,*degree*C*, +temperature_max_02,temperature_max_02,WorldClim_2.1_BCC-CSM2-MR_ssp585_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Feb,max T Feb,february,degrees Celsius,*degree*C*, +temperature_max_03,temperature_max_03,WorldClim_2.1_BCC-CSM2-MR_ssp585_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Mar,max T Mar,march,degrees Celsius,*degree*C*, +temperature_max_04,temperature_max_04,WorldClim_2.1_BCC-CSM2-MR_ssp585_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Apr,max T Apr,april,degrees Celsius,*degree*C*, +temperature_max_05,temperature_max_05,WorldClim_2.1_BCC-CSM2-MR_ssp585_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature May,max T May,may,degrees Celsius,*degree*C*, +temperature_max_06,temperature_max_06,WorldClim_2.1_BCC-CSM2-MR_ssp585_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jun,max T Jun,june,degrees Celsius,*degree*C*, +temperature_max_07,temperature_max_07,WorldClim_2.1_BCC-CSM2-MR_ssp585_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jul,max T Jul,july,degrees Celsius,*degree*C*, +temperature_max_08,temperature_max_08,WorldClim_2.1_BCC-CSM2-MR_ssp585_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Aug,max T Aug,august,degrees Celsius,*degree*C*, +temperature_max_09,temperature_max_09,WorldClim_2.1_BCC-CSM2-MR_ssp585_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Sep,max T Sep,september,degrees Celsius,*degree*C*, +temperature_max_10,temperature_max_10,WorldClim_2.1_BCC-CSM2-MR_ssp585_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Oct,max T Oct,october,degrees Celsius,*degree*C*, +temperature_max_11,temperature_max_11,WorldClim_2.1_BCC-CSM2-MR_ssp585_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Nov,max T Nov,november,degrees Celsius,*degree*C*, +temperature_max_12,temperature_max_12,WorldClim_2.1_BCC-CSM2-MR_ssp585_5m,TRUE,WorldClim_2.1_BCC-CSM2-MR_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Dec,max T Dec,december,degrees Celsius,*degree*C*, +bio01,bio01,WorldClim_2.1_CMCC-ESM2_ssp126_10m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual mean temperature,ann. mean T,year,degrees Celsius,*degree*C*, +bio02,bio02,WorldClim_2.1_CMCC-ESM2_ssp126_10m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean diurnal range,diurn. range,year,degrees Celsius,*degree*C*, +bio03,bio03,WorldClim_2.1_CMCC-ESM2_ssp126_10m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,isothermality,isothermality,year,,, +bio04,bio04,WorldClim_2.1_CMCC-ESM2_ssp126_10m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature seasonality,T season.,year,degrees Celsius,*degree*C*, +bio05,bio05,WorldClim_2.1_CMCC-ESM2_ssp126_10m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature of warmest month,max. T of warmest mo.,year,degrees Celsius,*degree*C*, +bio06,bio06,WorldClim_2.1_CMCC-ESM2_ssp126_10m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature of coldest month,min. T of coldest mo.,year,degrees Celsius,*degree*C*, +bio07,bio07,WorldClim_2.1_CMCC-ESM2_ssp126_10m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature annual range (bio05-bio06),T ann. Range,year,degrees Celsius,*degree*C*, +bio08,bio08,WorldClim_2.1_CMCC-ESM2_ssp126_10m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of wettest quarter,mean T of wettest qtr,year,degrees Celsius,*degree*C*, +bio09,bio09,WorldClim_2.1_CMCC-ESM2_ssp126_10m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of driest quarter,mean T of driest qtr,year,degrees Celsius,*degree*C*, +bio10,bio10,WorldClim_2.1_CMCC-ESM2_ssp126_10m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of warmest quarter,mean T of warmest qtr,year,degrees Celsius,*degree*C*, +bio11,bio11,WorldClim_2.1_CMCC-ESM2_ssp126_10m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of coldest quarter,mean T of coldest qtr,year,degrees Celsius,*degree*C*, +bio12,bio12,WorldClim_2.1_CMCC-ESM2_ssp126_10m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual precipitation,ann. P,year,mm per year,*mm~yr^-1*, +bio13,bio13,WorldClim_2.1_CMCC-ESM2_ssp126_10m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest month,P of wettest mo.,year,mm per month,*mm~mo^-1*, +bio14,bio14,WorldClim_2.1_CMCC-ESM2_ssp126_10m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest month,P of driest mo.,year,mm per month,*mm~mo^-1*, +bio15,bio15,WorldClim_2.1_CMCC-ESM2_ssp126_10m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation seasonality (coeff var),P season.,year,,, +bio16,bio16,WorldClim_2.1_CMCC-ESM2_ssp126_10m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest quarter,P of wettest qtr,year,mm per quarter,*mm~qtr^-1*, +bio17,bio17,WorldClim_2.1_CMCC-ESM2_ssp126_10m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest quarter,P of driest qtr,year,mm per quarter,*mm~qtr^-1*, +bio18,bio18,WorldClim_2.1_CMCC-ESM2_ssp126_10m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of warmest quarter,P of warmest qtr,year,mm per quarter,*mm~qtr^-1*, +bio19,bio19,WorldClim_2.1_CMCC-ESM2_ssp126_10m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of coldest quarter,P of coldest qtr,year,mm per quarter,*mm~qtr^-1*, +precipitation_01,precipitation_01,WorldClim_2.1_CMCC-ESM2_ssp126_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jan,P Jan,january,mm per month,*mm~mo^-1*, +precipitation_02,precipitation_02,WorldClim_2.1_CMCC-ESM2_ssp126_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Feb,P Feb,february,mm per month,*mm~mo^-1*, +precipitation_03,precipitation_03,WorldClim_2.1_CMCC-ESM2_ssp126_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Mar,P Mar,march,mm per month,*mm~mo^-1*, +precipitation_04,precipitation_04,WorldClim_2.1_CMCC-ESM2_ssp126_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Apr,P Apr,april,mm per month,*mm~mo^-1*, +precipitation_05,precipitation_05,WorldClim_2.1_CMCC-ESM2_ssp126_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation May,P May,may,mm per month,*mm~mo^-1*, +precipitation_06,precipitation_06,WorldClim_2.1_CMCC-ESM2_ssp126_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jun,P Jun,june,mm per month,*mm~mo^-1*, +precipitation_07,precipitation_07,WorldClim_2.1_CMCC-ESM2_ssp126_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jul,P Jul,july,mm per month,*mm~mo^-1*, +precipitation_08,precipitation_08,WorldClim_2.1_CMCC-ESM2_ssp126_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Aug,P Aug,august,mm per month,*mm~mo^-1*, +precipitation_09,precipitation_09,WorldClim_2.1_CMCC-ESM2_ssp126_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Sep,P Sep,september,mm per month,*mm~mo^-1*, +precipitation_10,precipitation_10,WorldClim_2.1_CMCC-ESM2_ssp126_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Oct,P Oct,october,mm per month,*mm~mo^-1*, +precipitation_11,precipitation_11,WorldClim_2.1_CMCC-ESM2_ssp126_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Nov,P Nov,november,mm per month,*mm~mo^-1*, +precipitation_12,precipitation_12,WorldClim_2.1_CMCC-ESM2_ssp126_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Dec,P Dec,december,mm per month,*mm~mo^-1*, +temperature_min_01,temperature_min_01,WorldClim_2.1_CMCC-ESM2_ssp126_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jan,min T Jan,january,degrees Celsius,*degree*C*, +temperature_min_02,temperature_min_02,WorldClim_2.1_CMCC-ESM2_ssp126_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Feb,min T Feb,february,degrees Celsius,*degree*C*, +temperature_min_03,temperature_min_03,WorldClim_2.1_CMCC-ESM2_ssp126_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Mar,min T Mar,march,degrees Celsius,*degree*C*, +temperature_min_04,temperature_min_04,WorldClim_2.1_CMCC-ESM2_ssp126_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Apr,min T Apr,april,degrees Celsius,*degree*C*, +temperature_min_05,temperature_min_05,WorldClim_2.1_CMCC-ESM2_ssp126_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature May,min T May,may,degrees Celsius,*degree*C*, +temperature_min_06,temperature_min_06,WorldClim_2.1_CMCC-ESM2_ssp126_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jun,min T Jun,june,degrees Celsius,*degree*C*, +temperature_min_07,temperature_min_07,WorldClim_2.1_CMCC-ESM2_ssp126_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jul,min T Jul,july,degrees Celsius,*degree*C*, +temperature_min_08,temperature_min_08,WorldClim_2.1_CMCC-ESM2_ssp126_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Aug,min T Aug,august,degrees Celsius,*degree*C*, +temperature_min_09,temperature_min_09,WorldClim_2.1_CMCC-ESM2_ssp126_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Sep,min T Sep,september,degrees Celsius,*degree*C*, +temperature_min_10,temperature_min_10,WorldClim_2.1_CMCC-ESM2_ssp126_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Oct,min T Oct,october,degrees Celsius,*degree*C*, +temperature_min_11,temperature_min_11,WorldClim_2.1_CMCC-ESM2_ssp126_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Nov,min T Nov,november,degrees Celsius,*degree*C*, +temperature_min_12,temperature_min_12,WorldClim_2.1_CMCC-ESM2_ssp126_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Dec,min T Dec,december,degrees Celsius,*degree*C*, +temperature_max_01,temperature_max_01,WorldClim_2.1_CMCC-ESM2_ssp126_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jan,max T Jan,january,degrees Celsius,*degree*C*, +temperature_max_02,temperature_max_02,WorldClim_2.1_CMCC-ESM2_ssp126_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Feb,max T Feb,february,degrees Celsius,*degree*C*, +temperature_max_03,temperature_max_03,WorldClim_2.1_CMCC-ESM2_ssp126_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Mar,max T Mar,march,degrees Celsius,*degree*C*, +temperature_max_04,temperature_max_04,WorldClim_2.1_CMCC-ESM2_ssp126_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Apr,max T Apr,april,degrees Celsius,*degree*C*, +temperature_max_05,temperature_max_05,WorldClim_2.1_CMCC-ESM2_ssp126_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature May,max T May,may,degrees Celsius,*degree*C*, +temperature_max_06,temperature_max_06,WorldClim_2.1_CMCC-ESM2_ssp126_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jun,max T Jun,june,degrees Celsius,*degree*C*, +temperature_max_07,temperature_max_07,WorldClim_2.1_CMCC-ESM2_ssp126_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jul,max T Jul,july,degrees Celsius,*degree*C*, +temperature_max_08,temperature_max_08,WorldClim_2.1_CMCC-ESM2_ssp126_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Aug,max T Aug,august,degrees Celsius,*degree*C*, +temperature_max_09,temperature_max_09,WorldClim_2.1_CMCC-ESM2_ssp126_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Sep,max T Sep,september,degrees Celsius,*degree*C*, +temperature_max_10,temperature_max_10,WorldClim_2.1_CMCC-ESM2_ssp126_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Oct,max T Oct,october,degrees Celsius,*degree*C*, +temperature_max_11,temperature_max_11,WorldClim_2.1_CMCC-ESM2_ssp126_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Nov,max T Nov,november,degrees Celsius,*degree*C*, +temperature_max_12,temperature_max_12,WorldClim_2.1_CMCC-ESM2_ssp126_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Dec,max T Dec,december,degrees Celsius,*degree*C*, +bio01,bio01,WorldClim_2.1_CMCC-ESM2_ssp126_5m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual mean temperature,ann. mean T,year,degrees Celsius,*degree*C*, +bio02,bio02,WorldClim_2.1_CMCC-ESM2_ssp126_5m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean diurnal range,diurn. range,year,degrees Celsius,*degree*C*, +bio03,bio03,WorldClim_2.1_CMCC-ESM2_ssp126_5m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,isothermality,isothermality,year,,, +bio04,bio04,WorldClim_2.1_CMCC-ESM2_ssp126_5m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature seasonality,T season.,year,degrees Celsius,*degree*C*, +bio05,bio05,WorldClim_2.1_CMCC-ESM2_ssp126_5m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature of warmest month,max. T of warmest mo.,year,degrees Celsius,*degree*C*, +bio06,bio06,WorldClim_2.1_CMCC-ESM2_ssp126_5m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature of coldest month,min. T of coldest mo.,year,degrees Celsius,*degree*C*, +bio07,bio07,WorldClim_2.1_CMCC-ESM2_ssp126_5m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature annual range (bio05-bio06),T ann. Range,year,degrees Celsius,*degree*C*, +bio08,bio08,WorldClim_2.1_CMCC-ESM2_ssp126_5m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of wettest quarter,mean T of wettest qtr,year,degrees Celsius,*degree*C*, +bio09,bio09,WorldClim_2.1_CMCC-ESM2_ssp126_5m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of driest quarter,mean T of driest qtr,year,degrees Celsius,*degree*C*, +bio10,bio10,WorldClim_2.1_CMCC-ESM2_ssp126_5m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of warmest quarter,mean T of warmest qtr,year,degrees Celsius,*degree*C*, +bio11,bio11,WorldClim_2.1_CMCC-ESM2_ssp126_5m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of coldest quarter,mean T of coldest qtr,year,degrees Celsius,*degree*C*, +bio12,bio12,WorldClim_2.1_CMCC-ESM2_ssp126_5m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual precipitation,ann. P,year,mm per year,*mm~yr^-1*, +bio13,bio13,WorldClim_2.1_CMCC-ESM2_ssp126_5m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest month,P of wettest mo.,year,mm per month,*mm~mo^-1*, +bio14,bio14,WorldClim_2.1_CMCC-ESM2_ssp126_5m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest month,P of driest mo.,year,mm per month,*mm~mo^-1*, +bio15,bio15,WorldClim_2.1_CMCC-ESM2_ssp126_5m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation seasonality (coeff var),P season.,year,,, +bio16,bio16,WorldClim_2.1_CMCC-ESM2_ssp126_5m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest quarter,P of wettest qtr,year,mm per quarter,*mm~qtr^-1*, +bio17,bio17,WorldClim_2.1_CMCC-ESM2_ssp126_5m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest quarter,P of driest qtr,year,mm per quarter,*mm~qtr^-1*, +bio18,bio18,WorldClim_2.1_CMCC-ESM2_ssp126_5m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of warmest quarter,P of warmest qtr,year,mm per quarter,*mm~qtr^-1*, +bio19,bio19,WorldClim_2.1_CMCC-ESM2_ssp126_5m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of coldest quarter,P of coldest qtr,year,mm per quarter,*mm~qtr^-1*, +precipitation_01,precipitation_01,WorldClim_2.1_CMCC-ESM2_ssp126_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jan,P Jan,january,mm per month,*mm~mo^-1*, +precipitation_02,precipitation_02,WorldClim_2.1_CMCC-ESM2_ssp126_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Feb,P Feb,february,mm per month,*mm~mo^-1*, +precipitation_03,precipitation_03,WorldClim_2.1_CMCC-ESM2_ssp126_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Mar,P Mar,march,mm per month,*mm~mo^-1*, +precipitation_04,precipitation_04,WorldClim_2.1_CMCC-ESM2_ssp126_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Apr,P Apr,april,mm per month,*mm~mo^-1*, +precipitation_05,precipitation_05,WorldClim_2.1_CMCC-ESM2_ssp126_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation May,P May,may,mm per month,*mm~mo^-1*, +precipitation_06,precipitation_06,WorldClim_2.1_CMCC-ESM2_ssp126_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jun,P Jun,june,mm per month,*mm~mo^-1*, +precipitation_07,precipitation_07,WorldClim_2.1_CMCC-ESM2_ssp126_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jul,P Jul,july,mm per month,*mm~mo^-1*, +precipitation_08,precipitation_08,WorldClim_2.1_CMCC-ESM2_ssp126_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Aug,P Aug,august,mm per month,*mm~mo^-1*, +precipitation_09,precipitation_09,WorldClim_2.1_CMCC-ESM2_ssp126_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Sep,P Sep,september,mm per month,*mm~mo^-1*, +precipitation_10,precipitation_10,WorldClim_2.1_CMCC-ESM2_ssp126_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Oct,P Oct,october,mm per month,*mm~mo^-1*, +precipitation_11,precipitation_11,WorldClim_2.1_CMCC-ESM2_ssp126_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Nov,P Nov,november,mm per month,*mm~mo^-1*, +precipitation_12,precipitation_12,WorldClim_2.1_CMCC-ESM2_ssp126_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Dec,P Dec,december,mm per month,*mm~mo^-1*, +temperature_min_01,temperature_min_01,WorldClim_2.1_CMCC-ESM2_ssp126_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jan,min T Jan,january,degrees Celsius,*degree*C*, +temperature_min_02,temperature_min_02,WorldClim_2.1_CMCC-ESM2_ssp126_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Feb,min T Feb,february,degrees Celsius,*degree*C*, +temperature_min_03,temperature_min_03,WorldClim_2.1_CMCC-ESM2_ssp126_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Mar,min T Mar,march,degrees Celsius,*degree*C*, +temperature_min_04,temperature_min_04,WorldClim_2.1_CMCC-ESM2_ssp126_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Apr,min T Apr,april,degrees Celsius,*degree*C*, +temperature_min_05,temperature_min_05,WorldClim_2.1_CMCC-ESM2_ssp126_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature May,min T May,may,degrees Celsius,*degree*C*, +temperature_min_06,temperature_min_06,WorldClim_2.1_CMCC-ESM2_ssp126_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jun,min T Jun,june,degrees Celsius,*degree*C*, +temperature_min_07,temperature_min_07,WorldClim_2.1_CMCC-ESM2_ssp126_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jul,min T Jul,july,degrees Celsius,*degree*C*, +temperature_min_08,temperature_min_08,WorldClim_2.1_CMCC-ESM2_ssp126_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Aug,min T Aug,august,degrees Celsius,*degree*C*, +temperature_min_09,temperature_min_09,WorldClim_2.1_CMCC-ESM2_ssp126_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Sep,min T Sep,september,degrees Celsius,*degree*C*, +temperature_min_10,temperature_min_10,WorldClim_2.1_CMCC-ESM2_ssp126_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Oct,min T Oct,october,degrees Celsius,*degree*C*, +temperature_min_11,temperature_min_11,WorldClim_2.1_CMCC-ESM2_ssp126_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Nov,min T Nov,november,degrees Celsius,*degree*C*, +temperature_min_12,temperature_min_12,WorldClim_2.1_CMCC-ESM2_ssp126_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Dec,min T Dec,december,degrees Celsius,*degree*C*, +temperature_max_01,temperature_max_01,WorldClim_2.1_CMCC-ESM2_ssp126_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jan,max T Jan,january,degrees Celsius,*degree*C*, +temperature_max_02,temperature_max_02,WorldClim_2.1_CMCC-ESM2_ssp126_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Feb,max T Feb,february,degrees Celsius,*degree*C*, +temperature_max_03,temperature_max_03,WorldClim_2.1_CMCC-ESM2_ssp126_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Mar,max T Mar,march,degrees Celsius,*degree*C*, +temperature_max_04,temperature_max_04,WorldClim_2.1_CMCC-ESM2_ssp126_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Apr,max T Apr,april,degrees Celsius,*degree*C*, +temperature_max_05,temperature_max_05,WorldClim_2.1_CMCC-ESM2_ssp126_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature May,max T May,may,degrees Celsius,*degree*C*, +temperature_max_06,temperature_max_06,WorldClim_2.1_CMCC-ESM2_ssp126_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jun,max T Jun,june,degrees Celsius,*degree*C*, +temperature_max_07,temperature_max_07,WorldClim_2.1_CMCC-ESM2_ssp126_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jul,max T Jul,july,degrees Celsius,*degree*C*, +temperature_max_08,temperature_max_08,WorldClim_2.1_CMCC-ESM2_ssp126_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Aug,max T Aug,august,degrees Celsius,*degree*C*, +temperature_max_09,temperature_max_09,WorldClim_2.1_CMCC-ESM2_ssp126_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Sep,max T Sep,september,degrees Celsius,*degree*C*, +temperature_max_10,temperature_max_10,WorldClim_2.1_CMCC-ESM2_ssp126_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Oct,max T Oct,october,degrees Celsius,*degree*C*, +temperature_max_11,temperature_max_11,WorldClim_2.1_CMCC-ESM2_ssp126_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Nov,max T Nov,november,degrees Celsius,*degree*C*, +temperature_max_12,temperature_max_12,WorldClim_2.1_CMCC-ESM2_ssp126_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Dec,max T Dec,december,degrees Celsius,*degree*C*, +bio01,bio01,WorldClim_2.1_CMCC-ESM2_ssp245_10m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual mean temperature,ann. mean T,year,degrees Celsius,*degree*C*, +bio02,bio02,WorldClim_2.1_CMCC-ESM2_ssp245_10m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean diurnal range,diurn. range,year,degrees Celsius,*degree*C*, +bio03,bio03,WorldClim_2.1_CMCC-ESM2_ssp245_10m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,isothermality,isothermality,year,,, +bio04,bio04,WorldClim_2.1_CMCC-ESM2_ssp245_10m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature seasonality,T season.,year,degrees Celsius,*degree*C*, +bio05,bio05,WorldClim_2.1_CMCC-ESM2_ssp245_10m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature of warmest month,max. T of warmest mo.,year,degrees Celsius,*degree*C*, +bio06,bio06,WorldClim_2.1_CMCC-ESM2_ssp245_10m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature of coldest month,min. T of coldest mo.,year,degrees Celsius,*degree*C*, +bio07,bio07,WorldClim_2.1_CMCC-ESM2_ssp245_10m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature annual range (bio05-bio06),T ann. Range,year,degrees Celsius,*degree*C*, +bio08,bio08,WorldClim_2.1_CMCC-ESM2_ssp245_10m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of wettest quarter,mean T of wettest qtr,year,degrees Celsius,*degree*C*, +bio09,bio09,WorldClim_2.1_CMCC-ESM2_ssp245_10m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of driest quarter,mean T of driest qtr,year,degrees Celsius,*degree*C*, +bio10,bio10,WorldClim_2.1_CMCC-ESM2_ssp245_10m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of warmest quarter,mean T of warmest qtr,year,degrees Celsius,*degree*C*, +bio11,bio11,WorldClim_2.1_CMCC-ESM2_ssp245_10m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of coldest quarter,mean T of coldest qtr,year,degrees Celsius,*degree*C*, +bio12,bio12,WorldClim_2.1_CMCC-ESM2_ssp245_10m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual precipitation,ann. P,year,mm per year,*mm~yr^-1*, +bio13,bio13,WorldClim_2.1_CMCC-ESM2_ssp245_10m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest month,P of wettest mo.,year,mm per month,*mm~mo^-1*, +bio14,bio14,WorldClim_2.1_CMCC-ESM2_ssp245_10m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest month,P of driest mo.,year,mm per month,*mm~mo^-1*, +bio15,bio15,WorldClim_2.1_CMCC-ESM2_ssp245_10m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation seasonality (coeff var),P season.,year,,, +bio16,bio16,WorldClim_2.1_CMCC-ESM2_ssp245_10m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest quarter,P of wettest qtr,year,mm per quarter,*mm~qtr^-1*, +bio17,bio17,WorldClim_2.1_CMCC-ESM2_ssp245_10m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest quarter,P of driest qtr,year,mm per quarter,*mm~qtr^-1*, +bio18,bio18,WorldClim_2.1_CMCC-ESM2_ssp245_10m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of warmest quarter,P of warmest qtr,year,mm per quarter,*mm~qtr^-1*, +bio19,bio19,WorldClim_2.1_CMCC-ESM2_ssp245_10m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of coldest quarter,P of coldest qtr,year,mm per quarter,*mm~qtr^-1*, +precipitation_01,precipitation_01,WorldClim_2.1_CMCC-ESM2_ssp245_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jan,P Jan,january,mm per month,*mm~mo^-1*, +precipitation_02,precipitation_02,WorldClim_2.1_CMCC-ESM2_ssp245_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Feb,P Feb,february,mm per month,*mm~mo^-1*, +precipitation_03,precipitation_03,WorldClim_2.1_CMCC-ESM2_ssp245_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Mar,P Mar,march,mm per month,*mm~mo^-1*, +precipitation_04,precipitation_04,WorldClim_2.1_CMCC-ESM2_ssp245_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Apr,P Apr,april,mm per month,*mm~mo^-1*, +precipitation_05,precipitation_05,WorldClim_2.1_CMCC-ESM2_ssp245_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation May,P May,may,mm per month,*mm~mo^-1*, +precipitation_06,precipitation_06,WorldClim_2.1_CMCC-ESM2_ssp245_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jun,P Jun,june,mm per month,*mm~mo^-1*, +precipitation_07,precipitation_07,WorldClim_2.1_CMCC-ESM2_ssp245_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jul,P Jul,july,mm per month,*mm~mo^-1*, +precipitation_08,precipitation_08,WorldClim_2.1_CMCC-ESM2_ssp245_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Aug,P Aug,august,mm per month,*mm~mo^-1*, +precipitation_09,precipitation_09,WorldClim_2.1_CMCC-ESM2_ssp245_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Sep,P Sep,september,mm per month,*mm~mo^-1*, +precipitation_10,precipitation_10,WorldClim_2.1_CMCC-ESM2_ssp245_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Oct,P Oct,october,mm per month,*mm~mo^-1*, +precipitation_11,precipitation_11,WorldClim_2.1_CMCC-ESM2_ssp245_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Nov,P Nov,november,mm per month,*mm~mo^-1*, +precipitation_12,precipitation_12,WorldClim_2.1_CMCC-ESM2_ssp245_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Dec,P Dec,december,mm per month,*mm~mo^-1*, +temperature_min_01,temperature_min_01,WorldClim_2.1_CMCC-ESM2_ssp245_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jan,min T Jan,january,degrees Celsius,*degree*C*, +temperature_min_02,temperature_min_02,WorldClim_2.1_CMCC-ESM2_ssp245_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Feb,min T Feb,february,degrees Celsius,*degree*C*, +temperature_min_03,temperature_min_03,WorldClim_2.1_CMCC-ESM2_ssp245_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Mar,min T Mar,march,degrees Celsius,*degree*C*, +temperature_min_04,temperature_min_04,WorldClim_2.1_CMCC-ESM2_ssp245_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Apr,min T Apr,april,degrees Celsius,*degree*C*, +temperature_min_05,temperature_min_05,WorldClim_2.1_CMCC-ESM2_ssp245_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature May,min T May,may,degrees Celsius,*degree*C*, +temperature_min_06,temperature_min_06,WorldClim_2.1_CMCC-ESM2_ssp245_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jun,min T Jun,june,degrees Celsius,*degree*C*, +temperature_min_07,temperature_min_07,WorldClim_2.1_CMCC-ESM2_ssp245_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jul,min T Jul,july,degrees Celsius,*degree*C*, +temperature_min_08,temperature_min_08,WorldClim_2.1_CMCC-ESM2_ssp245_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Aug,min T Aug,august,degrees Celsius,*degree*C*, +temperature_min_09,temperature_min_09,WorldClim_2.1_CMCC-ESM2_ssp245_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Sep,min T Sep,september,degrees Celsius,*degree*C*, +temperature_min_10,temperature_min_10,WorldClim_2.1_CMCC-ESM2_ssp245_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Oct,min T Oct,october,degrees Celsius,*degree*C*, +temperature_min_11,temperature_min_11,WorldClim_2.1_CMCC-ESM2_ssp245_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Nov,min T Nov,november,degrees Celsius,*degree*C*, +temperature_min_12,temperature_min_12,WorldClim_2.1_CMCC-ESM2_ssp245_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Dec,min T Dec,december,degrees Celsius,*degree*C*, +temperature_max_01,temperature_max_01,WorldClim_2.1_CMCC-ESM2_ssp245_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jan,max T Jan,january,degrees Celsius,*degree*C*, +temperature_max_02,temperature_max_02,WorldClim_2.1_CMCC-ESM2_ssp245_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Feb,max T Feb,february,degrees Celsius,*degree*C*, +temperature_max_03,temperature_max_03,WorldClim_2.1_CMCC-ESM2_ssp245_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Mar,max T Mar,march,degrees Celsius,*degree*C*, +temperature_max_04,temperature_max_04,WorldClim_2.1_CMCC-ESM2_ssp245_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Apr,max T Apr,april,degrees Celsius,*degree*C*, +temperature_max_05,temperature_max_05,WorldClim_2.1_CMCC-ESM2_ssp245_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature May,max T May,may,degrees Celsius,*degree*C*, +temperature_max_06,temperature_max_06,WorldClim_2.1_CMCC-ESM2_ssp245_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jun,max T Jun,june,degrees Celsius,*degree*C*, +temperature_max_07,temperature_max_07,WorldClim_2.1_CMCC-ESM2_ssp245_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jul,max T Jul,july,degrees Celsius,*degree*C*, +temperature_max_08,temperature_max_08,WorldClim_2.1_CMCC-ESM2_ssp245_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Aug,max T Aug,august,degrees Celsius,*degree*C*, +temperature_max_09,temperature_max_09,WorldClim_2.1_CMCC-ESM2_ssp245_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Sep,max T Sep,september,degrees Celsius,*degree*C*, +temperature_max_10,temperature_max_10,WorldClim_2.1_CMCC-ESM2_ssp245_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Oct,max T Oct,october,degrees Celsius,*degree*C*, +temperature_max_11,temperature_max_11,WorldClim_2.1_CMCC-ESM2_ssp245_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Nov,max T Nov,november,degrees Celsius,*degree*C*, +temperature_max_12,temperature_max_12,WorldClim_2.1_CMCC-ESM2_ssp245_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Dec,max T Dec,december,degrees Celsius,*degree*C*, +bio01,bio01,WorldClim_2.1_CMCC-ESM2_ssp245_5m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual mean temperature,ann. mean T,year,degrees Celsius,*degree*C*, +bio02,bio02,WorldClim_2.1_CMCC-ESM2_ssp245_5m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean diurnal range,diurn. range,year,degrees Celsius,*degree*C*, +bio03,bio03,WorldClim_2.1_CMCC-ESM2_ssp245_5m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,isothermality,isothermality,year,,, +bio04,bio04,WorldClim_2.1_CMCC-ESM2_ssp245_5m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature seasonality,T season.,year,degrees Celsius,*degree*C*, +bio05,bio05,WorldClim_2.1_CMCC-ESM2_ssp245_5m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature of warmest month,max. T of warmest mo.,year,degrees Celsius,*degree*C*, +bio06,bio06,WorldClim_2.1_CMCC-ESM2_ssp245_5m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature of coldest month,min. T of coldest mo.,year,degrees Celsius,*degree*C*, +bio07,bio07,WorldClim_2.1_CMCC-ESM2_ssp245_5m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature annual range (bio05-bio06),T ann. Range,year,degrees Celsius,*degree*C*, +bio08,bio08,WorldClim_2.1_CMCC-ESM2_ssp245_5m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of wettest quarter,mean T of wettest qtr,year,degrees Celsius,*degree*C*, +bio09,bio09,WorldClim_2.1_CMCC-ESM2_ssp245_5m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of driest quarter,mean T of driest qtr,year,degrees Celsius,*degree*C*, +bio10,bio10,WorldClim_2.1_CMCC-ESM2_ssp245_5m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of warmest quarter,mean T of warmest qtr,year,degrees Celsius,*degree*C*, +bio11,bio11,WorldClim_2.1_CMCC-ESM2_ssp245_5m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of coldest quarter,mean T of coldest qtr,year,degrees Celsius,*degree*C*, +bio12,bio12,WorldClim_2.1_CMCC-ESM2_ssp245_5m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual precipitation,ann. P,year,mm per year,*mm~yr^-1*, +bio13,bio13,WorldClim_2.1_CMCC-ESM2_ssp245_5m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest month,P of wettest mo.,year,mm per month,*mm~mo^-1*, +bio14,bio14,WorldClim_2.1_CMCC-ESM2_ssp245_5m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest month,P of driest mo.,year,mm per month,*mm~mo^-1*, +bio15,bio15,WorldClim_2.1_CMCC-ESM2_ssp245_5m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation seasonality (coeff var),P season.,year,,, +bio16,bio16,WorldClim_2.1_CMCC-ESM2_ssp245_5m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest quarter,P of wettest qtr,year,mm per quarter,*mm~qtr^-1*, +bio17,bio17,WorldClim_2.1_CMCC-ESM2_ssp245_5m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest quarter,P of driest qtr,year,mm per quarter,*mm~qtr^-1*, +bio18,bio18,WorldClim_2.1_CMCC-ESM2_ssp245_5m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of warmest quarter,P of warmest qtr,year,mm per quarter,*mm~qtr^-1*, +bio19,bio19,WorldClim_2.1_CMCC-ESM2_ssp245_5m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of coldest quarter,P of coldest qtr,year,mm per quarter,*mm~qtr^-1*, +precipitation_01,precipitation_01,WorldClim_2.1_CMCC-ESM2_ssp245_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jan,P Jan,january,mm per month,*mm~mo^-1*, +precipitation_02,precipitation_02,WorldClim_2.1_CMCC-ESM2_ssp245_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Feb,P Feb,february,mm per month,*mm~mo^-1*, +precipitation_03,precipitation_03,WorldClim_2.1_CMCC-ESM2_ssp245_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Mar,P Mar,march,mm per month,*mm~mo^-1*, +precipitation_04,precipitation_04,WorldClim_2.1_CMCC-ESM2_ssp245_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Apr,P Apr,april,mm per month,*mm~mo^-1*, +precipitation_05,precipitation_05,WorldClim_2.1_CMCC-ESM2_ssp245_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation May,P May,may,mm per month,*mm~mo^-1*, +precipitation_06,precipitation_06,WorldClim_2.1_CMCC-ESM2_ssp245_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jun,P Jun,june,mm per month,*mm~mo^-1*, +precipitation_07,precipitation_07,WorldClim_2.1_CMCC-ESM2_ssp245_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jul,P Jul,july,mm per month,*mm~mo^-1*, +precipitation_08,precipitation_08,WorldClim_2.1_CMCC-ESM2_ssp245_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Aug,P Aug,august,mm per month,*mm~mo^-1*, +precipitation_09,precipitation_09,WorldClim_2.1_CMCC-ESM2_ssp245_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Sep,P Sep,september,mm per month,*mm~mo^-1*, +precipitation_10,precipitation_10,WorldClim_2.1_CMCC-ESM2_ssp245_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Oct,P Oct,october,mm per month,*mm~mo^-1*, +precipitation_11,precipitation_11,WorldClim_2.1_CMCC-ESM2_ssp245_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Nov,P Nov,november,mm per month,*mm~mo^-1*, +precipitation_12,precipitation_12,WorldClim_2.1_CMCC-ESM2_ssp245_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Dec,P Dec,december,mm per month,*mm~mo^-1*, +temperature_min_01,temperature_min_01,WorldClim_2.1_CMCC-ESM2_ssp245_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jan,min T Jan,january,degrees Celsius,*degree*C*, +temperature_min_02,temperature_min_02,WorldClim_2.1_CMCC-ESM2_ssp245_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Feb,min T Feb,february,degrees Celsius,*degree*C*, +temperature_min_03,temperature_min_03,WorldClim_2.1_CMCC-ESM2_ssp245_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Mar,min T Mar,march,degrees Celsius,*degree*C*, +temperature_min_04,temperature_min_04,WorldClim_2.1_CMCC-ESM2_ssp245_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Apr,min T Apr,april,degrees Celsius,*degree*C*, +temperature_min_05,temperature_min_05,WorldClim_2.1_CMCC-ESM2_ssp245_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature May,min T May,may,degrees Celsius,*degree*C*, +temperature_min_06,temperature_min_06,WorldClim_2.1_CMCC-ESM2_ssp245_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jun,min T Jun,june,degrees Celsius,*degree*C*, +temperature_min_07,temperature_min_07,WorldClim_2.1_CMCC-ESM2_ssp245_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jul,min T Jul,july,degrees Celsius,*degree*C*, +temperature_min_08,temperature_min_08,WorldClim_2.1_CMCC-ESM2_ssp245_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Aug,min T Aug,august,degrees Celsius,*degree*C*, +temperature_min_09,temperature_min_09,WorldClim_2.1_CMCC-ESM2_ssp245_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Sep,min T Sep,september,degrees Celsius,*degree*C*, +temperature_min_10,temperature_min_10,WorldClim_2.1_CMCC-ESM2_ssp245_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Oct,min T Oct,october,degrees Celsius,*degree*C*, +temperature_min_11,temperature_min_11,WorldClim_2.1_CMCC-ESM2_ssp245_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Nov,min T Nov,november,degrees Celsius,*degree*C*, +temperature_min_12,temperature_min_12,WorldClim_2.1_CMCC-ESM2_ssp245_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Dec,min T Dec,december,degrees Celsius,*degree*C*, +temperature_max_01,temperature_max_01,WorldClim_2.1_CMCC-ESM2_ssp245_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jan,max T Jan,january,degrees Celsius,*degree*C*, +temperature_max_02,temperature_max_02,WorldClim_2.1_CMCC-ESM2_ssp245_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Feb,max T Feb,february,degrees Celsius,*degree*C*, +temperature_max_03,temperature_max_03,WorldClim_2.1_CMCC-ESM2_ssp245_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Mar,max T Mar,march,degrees Celsius,*degree*C*, +temperature_max_04,temperature_max_04,WorldClim_2.1_CMCC-ESM2_ssp245_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Apr,max T Apr,april,degrees Celsius,*degree*C*, +temperature_max_05,temperature_max_05,WorldClim_2.1_CMCC-ESM2_ssp245_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature May,max T May,may,degrees Celsius,*degree*C*, +temperature_max_06,temperature_max_06,WorldClim_2.1_CMCC-ESM2_ssp245_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jun,max T Jun,june,degrees Celsius,*degree*C*, +temperature_max_07,temperature_max_07,WorldClim_2.1_CMCC-ESM2_ssp245_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jul,max T Jul,july,degrees Celsius,*degree*C*, +temperature_max_08,temperature_max_08,WorldClim_2.1_CMCC-ESM2_ssp245_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Aug,max T Aug,august,degrees Celsius,*degree*C*, +temperature_max_09,temperature_max_09,WorldClim_2.1_CMCC-ESM2_ssp245_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Sep,max T Sep,september,degrees Celsius,*degree*C*, +temperature_max_10,temperature_max_10,WorldClim_2.1_CMCC-ESM2_ssp245_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Oct,max T Oct,october,degrees Celsius,*degree*C*, +temperature_max_11,temperature_max_11,WorldClim_2.1_CMCC-ESM2_ssp245_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Nov,max T Nov,november,degrees Celsius,*degree*C*, +temperature_max_12,temperature_max_12,WorldClim_2.1_CMCC-ESM2_ssp245_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Dec,max T Dec,december,degrees Celsius,*degree*C*, +bio01,bio01,WorldClim_2.1_CMCC-ESM2_ssp370_10m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual mean temperature,ann. mean T,year,degrees Celsius,*degree*C*, +bio02,bio02,WorldClim_2.1_CMCC-ESM2_ssp370_10m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean diurnal range,diurn. range,year,degrees Celsius,*degree*C*, +bio03,bio03,WorldClim_2.1_CMCC-ESM2_ssp370_10m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,isothermality,isothermality,year,,, +bio04,bio04,WorldClim_2.1_CMCC-ESM2_ssp370_10m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature seasonality,T season.,year,degrees Celsius,*degree*C*, +bio05,bio05,WorldClim_2.1_CMCC-ESM2_ssp370_10m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature of warmest month,max. T of warmest mo.,year,degrees Celsius,*degree*C*, +bio06,bio06,WorldClim_2.1_CMCC-ESM2_ssp370_10m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature of coldest month,min. T of coldest mo.,year,degrees Celsius,*degree*C*, +bio07,bio07,WorldClim_2.1_CMCC-ESM2_ssp370_10m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature annual range (bio05-bio06),T ann. Range,year,degrees Celsius,*degree*C*, +bio08,bio08,WorldClim_2.1_CMCC-ESM2_ssp370_10m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of wettest quarter,mean T of wettest qtr,year,degrees Celsius,*degree*C*, +bio09,bio09,WorldClim_2.1_CMCC-ESM2_ssp370_10m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of driest quarter,mean T of driest qtr,year,degrees Celsius,*degree*C*, +bio10,bio10,WorldClim_2.1_CMCC-ESM2_ssp370_10m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of warmest quarter,mean T of warmest qtr,year,degrees Celsius,*degree*C*, +bio11,bio11,WorldClim_2.1_CMCC-ESM2_ssp370_10m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of coldest quarter,mean T of coldest qtr,year,degrees Celsius,*degree*C*, +bio12,bio12,WorldClim_2.1_CMCC-ESM2_ssp370_10m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual precipitation,ann. P,year,mm per year,*mm~yr^-1*, +bio13,bio13,WorldClim_2.1_CMCC-ESM2_ssp370_10m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest month,P of wettest mo.,year,mm per month,*mm~mo^-1*, +bio14,bio14,WorldClim_2.1_CMCC-ESM2_ssp370_10m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest month,P of driest mo.,year,mm per month,*mm~mo^-1*, +bio15,bio15,WorldClim_2.1_CMCC-ESM2_ssp370_10m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation seasonality (coeff var),P season.,year,,, +bio16,bio16,WorldClim_2.1_CMCC-ESM2_ssp370_10m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest quarter,P of wettest qtr,year,mm per quarter,*mm~qtr^-1*, +bio17,bio17,WorldClim_2.1_CMCC-ESM2_ssp370_10m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest quarter,P of driest qtr,year,mm per quarter,*mm~qtr^-1*, +bio18,bio18,WorldClim_2.1_CMCC-ESM2_ssp370_10m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of warmest quarter,P of warmest qtr,year,mm per quarter,*mm~qtr^-1*, +bio19,bio19,WorldClim_2.1_CMCC-ESM2_ssp370_10m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of coldest quarter,P of coldest qtr,year,mm per quarter,*mm~qtr^-1*, +precipitation_01,precipitation_01,WorldClim_2.1_CMCC-ESM2_ssp370_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jan,P Jan,january,mm per month,*mm~mo^-1*, +precipitation_02,precipitation_02,WorldClim_2.1_CMCC-ESM2_ssp370_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Feb,P Feb,february,mm per month,*mm~mo^-1*, +precipitation_03,precipitation_03,WorldClim_2.1_CMCC-ESM2_ssp370_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Mar,P Mar,march,mm per month,*mm~mo^-1*, +precipitation_04,precipitation_04,WorldClim_2.1_CMCC-ESM2_ssp370_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Apr,P Apr,april,mm per month,*mm~mo^-1*, +precipitation_05,precipitation_05,WorldClim_2.1_CMCC-ESM2_ssp370_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation May,P May,may,mm per month,*mm~mo^-1*, +precipitation_06,precipitation_06,WorldClim_2.1_CMCC-ESM2_ssp370_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jun,P Jun,june,mm per month,*mm~mo^-1*, +precipitation_07,precipitation_07,WorldClim_2.1_CMCC-ESM2_ssp370_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jul,P Jul,july,mm per month,*mm~mo^-1*, +precipitation_08,precipitation_08,WorldClim_2.1_CMCC-ESM2_ssp370_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Aug,P Aug,august,mm per month,*mm~mo^-1*, +precipitation_09,precipitation_09,WorldClim_2.1_CMCC-ESM2_ssp370_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Sep,P Sep,september,mm per month,*mm~mo^-1*, +precipitation_10,precipitation_10,WorldClim_2.1_CMCC-ESM2_ssp370_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Oct,P Oct,october,mm per month,*mm~mo^-1*, +precipitation_11,precipitation_11,WorldClim_2.1_CMCC-ESM2_ssp370_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Nov,P Nov,november,mm per month,*mm~mo^-1*, +precipitation_12,precipitation_12,WorldClim_2.1_CMCC-ESM2_ssp370_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Dec,P Dec,december,mm per month,*mm~mo^-1*, +temperature_min_01,temperature_min_01,WorldClim_2.1_CMCC-ESM2_ssp370_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jan,min T Jan,january,degrees Celsius,*degree*C*, +temperature_min_02,temperature_min_02,WorldClim_2.1_CMCC-ESM2_ssp370_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Feb,min T Feb,february,degrees Celsius,*degree*C*, +temperature_min_03,temperature_min_03,WorldClim_2.1_CMCC-ESM2_ssp370_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Mar,min T Mar,march,degrees Celsius,*degree*C*, +temperature_min_04,temperature_min_04,WorldClim_2.1_CMCC-ESM2_ssp370_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Apr,min T Apr,april,degrees Celsius,*degree*C*, +temperature_min_05,temperature_min_05,WorldClim_2.1_CMCC-ESM2_ssp370_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature May,min T May,may,degrees Celsius,*degree*C*, +temperature_min_06,temperature_min_06,WorldClim_2.1_CMCC-ESM2_ssp370_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jun,min T Jun,june,degrees Celsius,*degree*C*, +temperature_min_07,temperature_min_07,WorldClim_2.1_CMCC-ESM2_ssp370_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jul,min T Jul,july,degrees Celsius,*degree*C*, +temperature_min_08,temperature_min_08,WorldClim_2.1_CMCC-ESM2_ssp370_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Aug,min T Aug,august,degrees Celsius,*degree*C*, +temperature_min_09,temperature_min_09,WorldClim_2.1_CMCC-ESM2_ssp370_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Sep,min T Sep,september,degrees Celsius,*degree*C*, +temperature_min_10,temperature_min_10,WorldClim_2.1_CMCC-ESM2_ssp370_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Oct,min T Oct,october,degrees Celsius,*degree*C*, +temperature_min_11,temperature_min_11,WorldClim_2.1_CMCC-ESM2_ssp370_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Nov,min T Nov,november,degrees Celsius,*degree*C*, +temperature_min_12,temperature_min_12,WorldClim_2.1_CMCC-ESM2_ssp370_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Dec,min T Dec,december,degrees Celsius,*degree*C*, +temperature_max_01,temperature_max_01,WorldClim_2.1_CMCC-ESM2_ssp370_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jan,max T Jan,january,degrees Celsius,*degree*C*, +temperature_max_02,temperature_max_02,WorldClim_2.1_CMCC-ESM2_ssp370_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Feb,max T Feb,february,degrees Celsius,*degree*C*, +temperature_max_03,temperature_max_03,WorldClim_2.1_CMCC-ESM2_ssp370_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Mar,max T Mar,march,degrees Celsius,*degree*C*, +temperature_max_04,temperature_max_04,WorldClim_2.1_CMCC-ESM2_ssp370_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Apr,max T Apr,april,degrees Celsius,*degree*C*, +temperature_max_05,temperature_max_05,WorldClim_2.1_CMCC-ESM2_ssp370_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature May,max T May,may,degrees Celsius,*degree*C*, +temperature_max_06,temperature_max_06,WorldClim_2.1_CMCC-ESM2_ssp370_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jun,max T Jun,june,degrees Celsius,*degree*C*, +temperature_max_07,temperature_max_07,WorldClim_2.1_CMCC-ESM2_ssp370_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jul,max T Jul,july,degrees Celsius,*degree*C*, +temperature_max_08,temperature_max_08,WorldClim_2.1_CMCC-ESM2_ssp370_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Aug,max T Aug,august,degrees Celsius,*degree*C*, +temperature_max_09,temperature_max_09,WorldClim_2.1_CMCC-ESM2_ssp370_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Sep,max T Sep,september,degrees Celsius,*degree*C*, +temperature_max_10,temperature_max_10,WorldClim_2.1_CMCC-ESM2_ssp370_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Oct,max T Oct,october,degrees Celsius,*degree*C*, +temperature_max_11,temperature_max_11,WorldClim_2.1_CMCC-ESM2_ssp370_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Nov,max T Nov,november,degrees Celsius,*degree*C*, +temperature_max_12,temperature_max_12,WorldClim_2.1_CMCC-ESM2_ssp370_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Dec,max T Dec,december,degrees Celsius,*degree*C*, +bio01,bio01,WorldClim_2.1_CMCC-ESM2_ssp370_5m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual mean temperature,ann. mean T,year,degrees Celsius,*degree*C*, +bio02,bio02,WorldClim_2.1_CMCC-ESM2_ssp370_5m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean diurnal range,diurn. range,year,degrees Celsius,*degree*C*, +bio03,bio03,WorldClim_2.1_CMCC-ESM2_ssp370_5m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,isothermality,isothermality,year,,, +bio04,bio04,WorldClim_2.1_CMCC-ESM2_ssp370_5m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature seasonality,T season.,year,degrees Celsius,*degree*C*, +bio05,bio05,WorldClim_2.1_CMCC-ESM2_ssp370_5m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature of warmest month,max. T of warmest mo.,year,degrees Celsius,*degree*C*, +bio06,bio06,WorldClim_2.1_CMCC-ESM2_ssp370_5m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature of coldest month,min. T of coldest mo.,year,degrees Celsius,*degree*C*, +bio07,bio07,WorldClim_2.1_CMCC-ESM2_ssp370_5m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature annual range (bio05-bio06),T ann. Range,year,degrees Celsius,*degree*C*, +bio08,bio08,WorldClim_2.1_CMCC-ESM2_ssp370_5m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of wettest quarter,mean T of wettest qtr,year,degrees Celsius,*degree*C*, +bio09,bio09,WorldClim_2.1_CMCC-ESM2_ssp370_5m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of driest quarter,mean T of driest qtr,year,degrees Celsius,*degree*C*, +bio10,bio10,WorldClim_2.1_CMCC-ESM2_ssp370_5m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of warmest quarter,mean T of warmest qtr,year,degrees Celsius,*degree*C*, +bio11,bio11,WorldClim_2.1_CMCC-ESM2_ssp370_5m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of coldest quarter,mean T of coldest qtr,year,degrees Celsius,*degree*C*, +bio12,bio12,WorldClim_2.1_CMCC-ESM2_ssp370_5m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual precipitation,ann. P,year,mm per year,*mm~yr^-1*, +bio13,bio13,WorldClim_2.1_CMCC-ESM2_ssp370_5m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest month,P of wettest mo.,year,mm per month,*mm~mo^-1*, +bio14,bio14,WorldClim_2.1_CMCC-ESM2_ssp370_5m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest month,P of driest mo.,year,mm per month,*mm~mo^-1*, +bio15,bio15,WorldClim_2.1_CMCC-ESM2_ssp370_5m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation seasonality (coeff var),P season.,year,,, +bio16,bio16,WorldClim_2.1_CMCC-ESM2_ssp370_5m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest quarter,P of wettest qtr,year,mm per quarter,*mm~qtr^-1*, +bio17,bio17,WorldClim_2.1_CMCC-ESM2_ssp370_5m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest quarter,P of driest qtr,year,mm per quarter,*mm~qtr^-1*, +bio18,bio18,WorldClim_2.1_CMCC-ESM2_ssp370_5m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of warmest quarter,P of warmest qtr,year,mm per quarter,*mm~qtr^-1*, +bio19,bio19,WorldClim_2.1_CMCC-ESM2_ssp370_5m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of coldest quarter,P of coldest qtr,year,mm per quarter,*mm~qtr^-1*, +precipitation_01,precipitation_01,WorldClim_2.1_CMCC-ESM2_ssp370_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jan,P Jan,january,mm per month,*mm~mo^-1*, +precipitation_02,precipitation_02,WorldClim_2.1_CMCC-ESM2_ssp370_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Feb,P Feb,february,mm per month,*mm~mo^-1*, +precipitation_03,precipitation_03,WorldClim_2.1_CMCC-ESM2_ssp370_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Mar,P Mar,march,mm per month,*mm~mo^-1*, +precipitation_04,precipitation_04,WorldClim_2.1_CMCC-ESM2_ssp370_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Apr,P Apr,april,mm per month,*mm~mo^-1*, +precipitation_05,precipitation_05,WorldClim_2.1_CMCC-ESM2_ssp370_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation May,P May,may,mm per month,*mm~mo^-1*, +precipitation_06,precipitation_06,WorldClim_2.1_CMCC-ESM2_ssp370_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jun,P Jun,june,mm per month,*mm~mo^-1*, +precipitation_07,precipitation_07,WorldClim_2.1_CMCC-ESM2_ssp370_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jul,P Jul,july,mm per month,*mm~mo^-1*, +precipitation_08,precipitation_08,WorldClim_2.1_CMCC-ESM2_ssp370_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Aug,P Aug,august,mm per month,*mm~mo^-1*, +precipitation_09,precipitation_09,WorldClim_2.1_CMCC-ESM2_ssp370_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Sep,P Sep,september,mm per month,*mm~mo^-1*, +precipitation_10,precipitation_10,WorldClim_2.1_CMCC-ESM2_ssp370_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Oct,P Oct,october,mm per month,*mm~mo^-1*, +precipitation_11,precipitation_11,WorldClim_2.1_CMCC-ESM2_ssp370_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Nov,P Nov,november,mm per month,*mm~mo^-1*, +precipitation_12,precipitation_12,WorldClim_2.1_CMCC-ESM2_ssp370_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Dec,P Dec,december,mm per month,*mm~mo^-1*, +temperature_min_01,temperature_min_01,WorldClim_2.1_CMCC-ESM2_ssp370_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jan,min T Jan,january,degrees Celsius,*degree*C*, +temperature_min_02,temperature_min_02,WorldClim_2.1_CMCC-ESM2_ssp370_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Feb,min T Feb,february,degrees Celsius,*degree*C*, +temperature_min_03,temperature_min_03,WorldClim_2.1_CMCC-ESM2_ssp370_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Mar,min T Mar,march,degrees Celsius,*degree*C*, +temperature_min_04,temperature_min_04,WorldClim_2.1_CMCC-ESM2_ssp370_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Apr,min T Apr,april,degrees Celsius,*degree*C*, +temperature_min_05,temperature_min_05,WorldClim_2.1_CMCC-ESM2_ssp370_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature May,min T May,may,degrees Celsius,*degree*C*, +temperature_min_06,temperature_min_06,WorldClim_2.1_CMCC-ESM2_ssp370_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jun,min T Jun,june,degrees Celsius,*degree*C*, +temperature_min_07,temperature_min_07,WorldClim_2.1_CMCC-ESM2_ssp370_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jul,min T Jul,july,degrees Celsius,*degree*C*, +temperature_min_08,temperature_min_08,WorldClim_2.1_CMCC-ESM2_ssp370_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Aug,min T Aug,august,degrees Celsius,*degree*C*, +temperature_min_09,temperature_min_09,WorldClim_2.1_CMCC-ESM2_ssp370_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Sep,min T Sep,september,degrees Celsius,*degree*C*, +temperature_min_10,temperature_min_10,WorldClim_2.1_CMCC-ESM2_ssp370_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Oct,min T Oct,october,degrees Celsius,*degree*C*, +temperature_min_11,temperature_min_11,WorldClim_2.1_CMCC-ESM2_ssp370_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Nov,min T Nov,november,degrees Celsius,*degree*C*, +temperature_min_12,temperature_min_12,WorldClim_2.1_CMCC-ESM2_ssp370_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Dec,min T Dec,december,degrees Celsius,*degree*C*, +temperature_max_01,temperature_max_01,WorldClim_2.1_CMCC-ESM2_ssp370_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jan,max T Jan,january,degrees Celsius,*degree*C*, +temperature_max_02,temperature_max_02,WorldClim_2.1_CMCC-ESM2_ssp370_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Feb,max T Feb,february,degrees Celsius,*degree*C*, +temperature_max_03,temperature_max_03,WorldClim_2.1_CMCC-ESM2_ssp370_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Mar,max T Mar,march,degrees Celsius,*degree*C*, +temperature_max_04,temperature_max_04,WorldClim_2.1_CMCC-ESM2_ssp370_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Apr,max T Apr,april,degrees Celsius,*degree*C*, +temperature_max_05,temperature_max_05,WorldClim_2.1_CMCC-ESM2_ssp370_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature May,max T May,may,degrees Celsius,*degree*C*, +temperature_max_06,temperature_max_06,WorldClim_2.1_CMCC-ESM2_ssp370_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jun,max T Jun,june,degrees Celsius,*degree*C*, +temperature_max_07,temperature_max_07,WorldClim_2.1_CMCC-ESM2_ssp370_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jul,max T Jul,july,degrees Celsius,*degree*C*, +temperature_max_08,temperature_max_08,WorldClim_2.1_CMCC-ESM2_ssp370_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Aug,max T Aug,august,degrees Celsius,*degree*C*, +temperature_max_09,temperature_max_09,WorldClim_2.1_CMCC-ESM2_ssp370_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Sep,max T Sep,september,degrees Celsius,*degree*C*, +temperature_max_10,temperature_max_10,WorldClim_2.1_CMCC-ESM2_ssp370_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Oct,max T Oct,october,degrees Celsius,*degree*C*, +temperature_max_11,temperature_max_11,WorldClim_2.1_CMCC-ESM2_ssp370_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Nov,max T Nov,november,degrees Celsius,*degree*C*, +temperature_max_12,temperature_max_12,WorldClim_2.1_CMCC-ESM2_ssp370_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Dec,max T Dec,december,degrees Celsius,*degree*C*, +bio01,bio01,WorldClim_2.1_CMCC-ESM2_ssp585_10m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual mean temperature,ann. mean T,year,degrees Celsius,*degree*C*, +bio02,bio02,WorldClim_2.1_CMCC-ESM2_ssp585_10m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean diurnal range,diurn. range,year,degrees Celsius,*degree*C*, +bio03,bio03,WorldClim_2.1_CMCC-ESM2_ssp585_10m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,isothermality,isothermality,year,,, +bio04,bio04,WorldClim_2.1_CMCC-ESM2_ssp585_10m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature seasonality,T season.,year,degrees Celsius,*degree*C*, +bio05,bio05,WorldClim_2.1_CMCC-ESM2_ssp585_10m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature of warmest month,max. T of warmest mo.,year,degrees Celsius,*degree*C*, +bio06,bio06,WorldClim_2.1_CMCC-ESM2_ssp585_10m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature of coldest month,min. T of coldest mo.,year,degrees Celsius,*degree*C*, +bio07,bio07,WorldClim_2.1_CMCC-ESM2_ssp585_10m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature annual range (bio05-bio06),T ann. Range,year,degrees Celsius,*degree*C*, +bio08,bio08,WorldClim_2.1_CMCC-ESM2_ssp585_10m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of wettest quarter,mean T of wettest qtr,year,degrees Celsius,*degree*C*, +bio09,bio09,WorldClim_2.1_CMCC-ESM2_ssp585_10m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of driest quarter,mean T of driest qtr,year,degrees Celsius,*degree*C*, +bio10,bio10,WorldClim_2.1_CMCC-ESM2_ssp585_10m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of warmest quarter,mean T of warmest qtr,year,degrees Celsius,*degree*C*, +bio11,bio11,WorldClim_2.1_CMCC-ESM2_ssp585_10m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of coldest quarter,mean T of coldest qtr,year,degrees Celsius,*degree*C*, +bio12,bio12,WorldClim_2.1_CMCC-ESM2_ssp585_10m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual precipitation,ann. P,year,mm per year,*mm~yr^-1*, +bio13,bio13,WorldClim_2.1_CMCC-ESM2_ssp585_10m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest month,P of wettest mo.,year,mm per month,*mm~mo^-1*, +bio14,bio14,WorldClim_2.1_CMCC-ESM2_ssp585_10m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest month,P of driest mo.,year,mm per month,*mm~mo^-1*, +bio15,bio15,WorldClim_2.1_CMCC-ESM2_ssp585_10m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation seasonality (coeff var),P season.,year,,, +bio16,bio16,WorldClim_2.1_CMCC-ESM2_ssp585_10m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest quarter,P of wettest qtr,year,mm per quarter,*mm~qtr^-1*, +bio17,bio17,WorldClim_2.1_CMCC-ESM2_ssp585_10m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest quarter,P of driest qtr,year,mm per quarter,*mm~qtr^-1*, +bio18,bio18,WorldClim_2.1_CMCC-ESM2_ssp585_10m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of warmest quarter,P of warmest qtr,year,mm per quarter,*mm~qtr^-1*, +bio19,bio19,WorldClim_2.1_CMCC-ESM2_ssp585_10m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of coldest quarter,P of coldest qtr,year,mm per quarter,*mm~qtr^-1*, +precipitation_01,precipitation_01,WorldClim_2.1_CMCC-ESM2_ssp585_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jan,P Jan,january,mm per month,*mm~mo^-1*, +precipitation_02,precipitation_02,WorldClim_2.1_CMCC-ESM2_ssp585_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Feb,P Feb,february,mm per month,*mm~mo^-1*, +precipitation_03,precipitation_03,WorldClim_2.1_CMCC-ESM2_ssp585_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Mar,P Mar,march,mm per month,*mm~mo^-1*, +precipitation_04,precipitation_04,WorldClim_2.1_CMCC-ESM2_ssp585_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Apr,P Apr,april,mm per month,*mm~mo^-1*, +precipitation_05,precipitation_05,WorldClim_2.1_CMCC-ESM2_ssp585_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation May,P May,may,mm per month,*mm~mo^-1*, +precipitation_06,precipitation_06,WorldClim_2.1_CMCC-ESM2_ssp585_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jun,P Jun,june,mm per month,*mm~mo^-1*, +precipitation_07,precipitation_07,WorldClim_2.1_CMCC-ESM2_ssp585_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jul,P Jul,july,mm per month,*mm~mo^-1*, +precipitation_08,precipitation_08,WorldClim_2.1_CMCC-ESM2_ssp585_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Aug,P Aug,august,mm per month,*mm~mo^-1*, +precipitation_09,precipitation_09,WorldClim_2.1_CMCC-ESM2_ssp585_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Sep,P Sep,september,mm per month,*mm~mo^-1*, +precipitation_10,precipitation_10,WorldClim_2.1_CMCC-ESM2_ssp585_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Oct,P Oct,october,mm per month,*mm~mo^-1*, +precipitation_11,precipitation_11,WorldClim_2.1_CMCC-ESM2_ssp585_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Nov,P Nov,november,mm per month,*mm~mo^-1*, +precipitation_12,precipitation_12,WorldClim_2.1_CMCC-ESM2_ssp585_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Dec,P Dec,december,mm per month,*mm~mo^-1*, +temperature_min_01,temperature_min_01,WorldClim_2.1_CMCC-ESM2_ssp585_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jan,min T Jan,january,degrees Celsius,*degree*C*, +temperature_min_02,temperature_min_02,WorldClim_2.1_CMCC-ESM2_ssp585_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Feb,min T Feb,february,degrees Celsius,*degree*C*, +temperature_min_03,temperature_min_03,WorldClim_2.1_CMCC-ESM2_ssp585_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Mar,min T Mar,march,degrees Celsius,*degree*C*, +temperature_min_04,temperature_min_04,WorldClim_2.1_CMCC-ESM2_ssp585_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Apr,min T Apr,april,degrees Celsius,*degree*C*, +temperature_min_05,temperature_min_05,WorldClim_2.1_CMCC-ESM2_ssp585_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature May,min T May,may,degrees Celsius,*degree*C*, +temperature_min_06,temperature_min_06,WorldClim_2.1_CMCC-ESM2_ssp585_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jun,min T Jun,june,degrees Celsius,*degree*C*, +temperature_min_07,temperature_min_07,WorldClim_2.1_CMCC-ESM2_ssp585_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jul,min T Jul,july,degrees Celsius,*degree*C*, +temperature_min_08,temperature_min_08,WorldClim_2.1_CMCC-ESM2_ssp585_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Aug,min T Aug,august,degrees Celsius,*degree*C*, +temperature_min_09,temperature_min_09,WorldClim_2.1_CMCC-ESM2_ssp585_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Sep,min T Sep,september,degrees Celsius,*degree*C*, +temperature_min_10,temperature_min_10,WorldClim_2.1_CMCC-ESM2_ssp585_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Oct,min T Oct,october,degrees Celsius,*degree*C*, +temperature_min_11,temperature_min_11,WorldClim_2.1_CMCC-ESM2_ssp585_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Nov,min T Nov,november,degrees Celsius,*degree*C*, +temperature_min_12,temperature_min_12,WorldClim_2.1_CMCC-ESM2_ssp585_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Dec,min T Dec,december,degrees Celsius,*degree*C*, +temperature_max_01,temperature_max_01,WorldClim_2.1_CMCC-ESM2_ssp585_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jan,max T Jan,january,degrees Celsius,*degree*C*, +temperature_max_02,temperature_max_02,WorldClim_2.1_CMCC-ESM2_ssp585_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Feb,max T Feb,february,degrees Celsius,*degree*C*, +temperature_max_03,temperature_max_03,WorldClim_2.1_CMCC-ESM2_ssp585_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Mar,max T Mar,march,degrees Celsius,*degree*C*, +temperature_max_04,temperature_max_04,WorldClim_2.1_CMCC-ESM2_ssp585_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Apr,max T Apr,april,degrees Celsius,*degree*C*, +temperature_max_05,temperature_max_05,WorldClim_2.1_CMCC-ESM2_ssp585_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature May,max T May,may,degrees Celsius,*degree*C*, +temperature_max_06,temperature_max_06,WorldClim_2.1_CMCC-ESM2_ssp585_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jun,max T Jun,june,degrees Celsius,*degree*C*, +temperature_max_07,temperature_max_07,WorldClim_2.1_CMCC-ESM2_ssp585_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jul,max T Jul,july,degrees Celsius,*degree*C*, +temperature_max_08,temperature_max_08,WorldClim_2.1_CMCC-ESM2_ssp585_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Aug,max T Aug,august,degrees Celsius,*degree*C*, +temperature_max_09,temperature_max_09,WorldClim_2.1_CMCC-ESM2_ssp585_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Sep,max T Sep,september,degrees Celsius,*degree*C*, +temperature_max_10,temperature_max_10,WorldClim_2.1_CMCC-ESM2_ssp585_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Oct,max T Oct,october,degrees Celsius,*degree*C*, +temperature_max_11,temperature_max_11,WorldClim_2.1_CMCC-ESM2_ssp585_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Nov,max T Nov,november,degrees Celsius,*degree*C*, +temperature_max_12,temperature_max_12,WorldClim_2.1_CMCC-ESM2_ssp585_10m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Dec,max T Dec,december,degrees Celsius,*degree*C*, +bio01,bio01,WorldClim_2.1_CMCC-ESM2_ssp585_5m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual mean temperature,ann. mean T,year,degrees Celsius,*degree*C*, +bio02,bio02,WorldClim_2.1_CMCC-ESM2_ssp585_5m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean diurnal range,diurn. range,year,degrees Celsius,*degree*C*, +bio03,bio03,WorldClim_2.1_CMCC-ESM2_ssp585_5m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,isothermality,isothermality,year,,, +bio04,bio04,WorldClim_2.1_CMCC-ESM2_ssp585_5m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature seasonality,T season.,year,degrees Celsius,*degree*C*, +bio05,bio05,WorldClim_2.1_CMCC-ESM2_ssp585_5m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature of warmest month,max. T of warmest mo.,year,degrees Celsius,*degree*C*, +bio06,bio06,WorldClim_2.1_CMCC-ESM2_ssp585_5m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature of coldest month,min. T of coldest mo.,year,degrees Celsius,*degree*C*, +bio07,bio07,WorldClim_2.1_CMCC-ESM2_ssp585_5m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature annual range (bio05-bio06),T ann. Range,year,degrees Celsius,*degree*C*, +bio08,bio08,WorldClim_2.1_CMCC-ESM2_ssp585_5m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of wettest quarter,mean T of wettest qtr,year,degrees Celsius,*degree*C*, +bio09,bio09,WorldClim_2.1_CMCC-ESM2_ssp585_5m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of driest quarter,mean T of driest qtr,year,degrees Celsius,*degree*C*, +bio10,bio10,WorldClim_2.1_CMCC-ESM2_ssp585_5m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of warmest quarter,mean T of warmest qtr,year,degrees Celsius,*degree*C*, +bio11,bio11,WorldClim_2.1_CMCC-ESM2_ssp585_5m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of coldest quarter,mean T of coldest qtr,year,degrees Celsius,*degree*C*, +bio12,bio12,WorldClim_2.1_CMCC-ESM2_ssp585_5m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual precipitation,ann. P,year,mm per year,*mm~yr^-1*, +bio13,bio13,WorldClim_2.1_CMCC-ESM2_ssp585_5m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest month,P of wettest mo.,year,mm per month,*mm~mo^-1*, +bio14,bio14,WorldClim_2.1_CMCC-ESM2_ssp585_5m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest month,P of driest mo.,year,mm per month,*mm~mo^-1*, +bio15,bio15,WorldClim_2.1_CMCC-ESM2_ssp585_5m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation seasonality (coeff var),P season.,year,,, +bio16,bio16,WorldClim_2.1_CMCC-ESM2_ssp585_5m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest quarter,P of wettest qtr,year,mm per quarter,*mm~qtr^-1*, +bio17,bio17,WorldClim_2.1_CMCC-ESM2_ssp585_5m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest quarter,P of driest qtr,year,mm per quarter,*mm~qtr^-1*, +bio18,bio18,WorldClim_2.1_CMCC-ESM2_ssp585_5m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of warmest quarter,P of warmest qtr,year,mm per quarter,*mm~qtr^-1*, +bio19,bio19,WorldClim_2.1_CMCC-ESM2_ssp585_5m,FALSE,WorldClim_2.1_CMCC-ESM2_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of coldest quarter,P of coldest qtr,year,mm per quarter,*mm~qtr^-1*, +precipitation_01,precipitation_01,WorldClim_2.1_CMCC-ESM2_ssp585_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jan,P Jan,january,mm per month,*mm~mo^-1*, +precipitation_02,precipitation_02,WorldClim_2.1_CMCC-ESM2_ssp585_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Feb,P Feb,february,mm per month,*mm~mo^-1*, +precipitation_03,precipitation_03,WorldClim_2.1_CMCC-ESM2_ssp585_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Mar,P Mar,march,mm per month,*mm~mo^-1*, +precipitation_04,precipitation_04,WorldClim_2.1_CMCC-ESM2_ssp585_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Apr,P Apr,april,mm per month,*mm~mo^-1*, +precipitation_05,precipitation_05,WorldClim_2.1_CMCC-ESM2_ssp585_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation May,P May,may,mm per month,*mm~mo^-1*, +precipitation_06,precipitation_06,WorldClim_2.1_CMCC-ESM2_ssp585_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jun,P Jun,june,mm per month,*mm~mo^-1*, +precipitation_07,precipitation_07,WorldClim_2.1_CMCC-ESM2_ssp585_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jul,P Jul,july,mm per month,*mm~mo^-1*, +precipitation_08,precipitation_08,WorldClim_2.1_CMCC-ESM2_ssp585_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Aug,P Aug,august,mm per month,*mm~mo^-1*, +precipitation_09,precipitation_09,WorldClim_2.1_CMCC-ESM2_ssp585_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Sep,P Sep,september,mm per month,*mm~mo^-1*, +precipitation_10,precipitation_10,WorldClim_2.1_CMCC-ESM2_ssp585_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Oct,P Oct,october,mm per month,*mm~mo^-1*, +precipitation_11,precipitation_11,WorldClim_2.1_CMCC-ESM2_ssp585_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Nov,P Nov,november,mm per month,*mm~mo^-1*, +precipitation_12,precipitation_12,WorldClim_2.1_CMCC-ESM2_ssp585_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Dec,P Dec,december,mm per month,*mm~mo^-1*, +temperature_min_01,temperature_min_01,WorldClim_2.1_CMCC-ESM2_ssp585_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jan,min T Jan,january,degrees Celsius,*degree*C*, +temperature_min_02,temperature_min_02,WorldClim_2.1_CMCC-ESM2_ssp585_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Feb,min T Feb,february,degrees Celsius,*degree*C*, +temperature_min_03,temperature_min_03,WorldClim_2.1_CMCC-ESM2_ssp585_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Mar,min T Mar,march,degrees Celsius,*degree*C*, +temperature_min_04,temperature_min_04,WorldClim_2.1_CMCC-ESM2_ssp585_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Apr,min T Apr,april,degrees Celsius,*degree*C*, +temperature_min_05,temperature_min_05,WorldClim_2.1_CMCC-ESM2_ssp585_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature May,min T May,may,degrees Celsius,*degree*C*, +temperature_min_06,temperature_min_06,WorldClim_2.1_CMCC-ESM2_ssp585_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jun,min T Jun,june,degrees Celsius,*degree*C*, +temperature_min_07,temperature_min_07,WorldClim_2.1_CMCC-ESM2_ssp585_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jul,min T Jul,july,degrees Celsius,*degree*C*, +temperature_min_08,temperature_min_08,WorldClim_2.1_CMCC-ESM2_ssp585_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Aug,min T Aug,august,degrees Celsius,*degree*C*, +temperature_min_09,temperature_min_09,WorldClim_2.1_CMCC-ESM2_ssp585_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Sep,min T Sep,september,degrees Celsius,*degree*C*, +temperature_min_10,temperature_min_10,WorldClim_2.1_CMCC-ESM2_ssp585_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Oct,min T Oct,october,degrees Celsius,*degree*C*, +temperature_min_11,temperature_min_11,WorldClim_2.1_CMCC-ESM2_ssp585_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Nov,min T Nov,november,degrees Celsius,*degree*C*, +temperature_min_12,temperature_min_12,WorldClim_2.1_CMCC-ESM2_ssp585_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Dec,min T Dec,december,degrees Celsius,*degree*C*, +temperature_max_01,temperature_max_01,WorldClim_2.1_CMCC-ESM2_ssp585_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jan,max T Jan,january,degrees Celsius,*degree*C*, +temperature_max_02,temperature_max_02,WorldClim_2.1_CMCC-ESM2_ssp585_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Feb,max T Feb,february,degrees Celsius,*degree*C*, +temperature_max_03,temperature_max_03,WorldClim_2.1_CMCC-ESM2_ssp585_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Mar,max T Mar,march,degrees Celsius,*degree*C*, +temperature_max_04,temperature_max_04,WorldClim_2.1_CMCC-ESM2_ssp585_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Apr,max T Apr,april,degrees Celsius,*degree*C*, +temperature_max_05,temperature_max_05,WorldClim_2.1_CMCC-ESM2_ssp585_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature May,max T May,may,degrees Celsius,*degree*C*, +temperature_max_06,temperature_max_06,WorldClim_2.1_CMCC-ESM2_ssp585_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jun,max T Jun,june,degrees Celsius,*degree*C*, +temperature_max_07,temperature_max_07,WorldClim_2.1_CMCC-ESM2_ssp585_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jul,max T Jul,july,degrees Celsius,*degree*C*, +temperature_max_08,temperature_max_08,WorldClim_2.1_CMCC-ESM2_ssp585_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Aug,max T Aug,august,degrees Celsius,*degree*C*, +temperature_max_09,temperature_max_09,WorldClim_2.1_CMCC-ESM2_ssp585_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Sep,max T Sep,september,degrees Celsius,*degree*C*, +temperature_max_10,temperature_max_10,WorldClim_2.1_CMCC-ESM2_ssp585_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Oct,max T Oct,october,degrees Celsius,*degree*C*, +temperature_max_11,temperature_max_11,WorldClim_2.1_CMCC-ESM2_ssp585_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Nov,max T Nov,november,degrees Celsius,*degree*C*, +temperature_max_12,temperature_max_12,WorldClim_2.1_CMCC-ESM2_ssp585_5m,TRUE,WorldClim_2.1_CMCC-ESM2_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Dec,max T Dec,december,degrees Celsius,*degree*C*, +bio01,bio01,WorldClim_2.1_EC-Earth3-Veg_ssp126_10m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual mean temperature,ann. mean T,year,degrees Celsius,*degree*C*, +bio02,bio02,WorldClim_2.1_EC-Earth3-Veg_ssp126_10m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean diurnal range,diurn. range,year,degrees Celsius,*degree*C*, +bio03,bio03,WorldClim_2.1_EC-Earth3-Veg_ssp126_10m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,isothermality,isothermality,year,,, +bio04,bio04,WorldClim_2.1_EC-Earth3-Veg_ssp126_10m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature seasonality,T season.,year,degrees Celsius,*degree*C*, +bio05,bio05,WorldClim_2.1_EC-Earth3-Veg_ssp126_10m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature of warmest month,max. T of warmest mo.,year,degrees Celsius,*degree*C*, +bio06,bio06,WorldClim_2.1_EC-Earth3-Veg_ssp126_10m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature of coldest month,min. T of coldest mo.,year,degrees Celsius,*degree*C*, +bio07,bio07,WorldClim_2.1_EC-Earth3-Veg_ssp126_10m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature annual range (bio05-bio06),T ann. Range,year,degrees Celsius,*degree*C*, +bio08,bio08,WorldClim_2.1_EC-Earth3-Veg_ssp126_10m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of wettest quarter,mean T of wettest qtr,year,degrees Celsius,*degree*C*, +bio09,bio09,WorldClim_2.1_EC-Earth3-Veg_ssp126_10m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of driest quarter,mean T of driest qtr,year,degrees Celsius,*degree*C*, +bio10,bio10,WorldClim_2.1_EC-Earth3-Veg_ssp126_10m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of warmest quarter,mean T of warmest qtr,year,degrees Celsius,*degree*C*, +bio11,bio11,WorldClim_2.1_EC-Earth3-Veg_ssp126_10m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of coldest quarter,mean T of coldest qtr,year,degrees Celsius,*degree*C*, +bio12,bio12,WorldClim_2.1_EC-Earth3-Veg_ssp126_10m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual precipitation,ann. P,year,mm per year,*mm~yr^-1*, +bio13,bio13,WorldClim_2.1_EC-Earth3-Veg_ssp126_10m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest month,P of wettest mo.,year,mm per month,*mm~mo^-1*, +bio14,bio14,WorldClim_2.1_EC-Earth3-Veg_ssp126_10m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest month,P of driest mo.,year,mm per month,*mm~mo^-1*, +bio15,bio15,WorldClim_2.1_EC-Earth3-Veg_ssp126_10m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation seasonality (coeff var),P season.,year,,, +bio16,bio16,WorldClim_2.1_EC-Earth3-Veg_ssp126_10m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest quarter,P of wettest qtr,year,mm per quarter,*mm~qtr^-1*, +bio17,bio17,WorldClim_2.1_EC-Earth3-Veg_ssp126_10m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest quarter,P of driest qtr,year,mm per quarter,*mm~qtr^-1*, +bio18,bio18,WorldClim_2.1_EC-Earth3-Veg_ssp126_10m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of warmest quarter,P of warmest qtr,year,mm per quarter,*mm~qtr^-1*, +bio19,bio19,WorldClim_2.1_EC-Earth3-Veg_ssp126_10m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of coldest quarter,P of coldest qtr,year,mm per quarter,*mm~qtr^-1*, +precipitation_01,precipitation_01,WorldClim_2.1_EC-Earth3-Veg_ssp126_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jan,P Jan,january,mm per month,*mm~mo^-1*, +precipitation_02,precipitation_02,WorldClim_2.1_EC-Earth3-Veg_ssp126_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Feb,P Feb,february,mm per month,*mm~mo^-1*, +precipitation_03,precipitation_03,WorldClim_2.1_EC-Earth3-Veg_ssp126_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Mar,P Mar,march,mm per month,*mm~mo^-1*, +precipitation_04,precipitation_04,WorldClim_2.1_EC-Earth3-Veg_ssp126_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Apr,P Apr,april,mm per month,*mm~mo^-1*, +precipitation_05,precipitation_05,WorldClim_2.1_EC-Earth3-Veg_ssp126_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation May,P May,may,mm per month,*mm~mo^-1*, +precipitation_06,precipitation_06,WorldClim_2.1_EC-Earth3-Veg_ssp126_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jun,P Jun,june,mm per month,*mm~mo^-1*, +precipitation_07,precipitation_07,WorldClim_2.1_EC-Earth3-Veg_ssp126_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jul,P Jul,july,mm per month,*mm~mo^-1*, +precipitation_08,precipitation_08,WorldClim_2.1_EC-Earth3-Veg_ssp126_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Aug,P Aug,august,mm per month,*mm~mo^-1*, +precipitation_09,precipitation_09,WorldClim_2.1_EC-Earth3-Veg_ssp126_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Sep,P Sep,september,mm per month,*mm~mo^-1*, +precipitation_10,precipitation_10,WorldClim_2.1_EC-Earth3-Veg_ssp126_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Oct,P Oct,october,mm per month,*mm~mo^-1*, +precipitation_11,precipitation_11,WorldClim_2.1_EC-Earth3-Veg_ssp126_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Nov,P Nov,november,mm per month,*mm~mo^-1*, +precipitation_12,precipitation_12,WorldClim_2.1_EC-Earth3-Veg_ssp126_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Dec,P Dec,december,mm per month,*mm~mo^-1*, +temperature_min_01,temperature_min_01,WorldClim_2.1_EC-Earth3-Veg_ssp126_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jan,min T Jan,january,degrees Celsius,*degree*C*, +temperature_min_02,temperature_min_02,WorldClim_2.1_EC-Earth3-Veg_ssp126_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Feb,min T Feb,february,degrees Celsius,*degree*C*, +temperature_min_03,temperature_min_03,WorldClim_2.1_EC-Earth3-Veg_ssp126_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Mar,min T Mar,march,degrees Celsius,*degree*C*, +temperature_min_04,temperature_min_04,WorldClim_2.1_EC-Earth3-Veg_ssp126_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Apr,min T Apr,april,degrees Celsius,*degree*C*, +temperature_min_05,temperature_min_05,WorldClim_2.1_EC-Earth3-Veg_ssp126_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature May,min T May,may,degrees Celsius,*degree*C*, +temperature_min_06,temperature_min_06,WorldClim_2.1_EC-Earth3-Veg_ssp126_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jun,min T Jun,june,degrees Celsius,*degree*C*, +temperature_min_07,temperature_min_07,WorldClim_2.1_EC-Earth3-Veg_ssp126_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jul,min T Jul,july,degrees Celsius,*degree*C*, +temperature_min_08,temperature_min_08,WorldClim_2.1_EC-Earth3-Veg_ssp126_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Aug,min T Aug,august,degrees Celsius,*degree*C*, +temperature_min_09,temperature_min_09,WorldClim_2.1_EC-Earth3-Veg_ssp126_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Sep,min T Sep,september,degrees Celsius,*degree*C*, +temperature_min_10,temperature_min_10,WorldClim_2.1_EC-Earth3-Veg_ssp126_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Oct,min T Oct,october,degrees Celsius,*degree*C*, +temperature_min_11,temperature_min_11,WorldClim_2.1_EC-Earth3-Veg_ssp126_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Nov,min T Nov,november,degrees Celsius,*degree*C*, +temperature_min_12,temperature_min_12,WorldClim_2.1_EC-Earth3-Veg_ssp126_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Dec,min T Dec,december,degrees Celsius,*degree*C*, +temperature_max_01,temperature_max_01,WorldClim_2.1_EC-Earth3-Veg_ssp126_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jan,max T Jan,january,degrees Celsius,*degree*C*, +temperature_max_02,temperature_max_02,WorldClim_2.1_EC-Earth3-Veg_ssp126_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Feb,max T Feb,february,degrees Celsius,*degree*C*, +temperature_max_03,temperature_max_03,WorldClim_2.1_EC-Earth3-Veg_ssp126_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Mar,max T Mar,march,degrees Celsius,*degree*C*, +temperature_max_04,temperature_max_04,WorldClim_2.1_EC-Earth3-Veg_ssp126_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Apr,max T Apr,april,degrees Celsius,*degree*C*, +temperature_max_05,temperature_max_05,WorldClim_2.1_EC-Earth3-Veg_ssp126_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature May,max T May,may,degrees Celsius,*degree*C*, +temperature_max_06,temperature_max_06,WorldClim_2.1_EC-Earth3-Veg_ssp126_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jun,max T Jun,june,degrees Celsius,*degree*C*, +temperature_max_07,temperature_max_07,WorldClim_2.1_EC-Earth3-Veg_ssp126_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jul,max T Jul,july,degrees Celsius,*degree*C*, +temperature_max_08,temperature_max_08,WorldClim_2.1_EC-Earth3-Veg_ssp126_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Aug,max T Aug,august,degrees Celsius,*degree*C*, +temperature_max_09,temperature_max_09,WorldClim_2.1_EC-Earth3-Veg_ssp126_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Sep,max T Sep,september,degrees Celsius,*degree*C*, +temperature_max_10,temperature_max_10,WorldClim_2.1_EC-Earth3-Veg_ssp126_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Oct,max T Oct,october,degrees Celsius,*degree*C*, +temperature_max_11,temperature_max_11,WorldClim_2.1_EC-Earth3-Veg_ssp126_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Nov,max T Nov,november,degrees Celsius,*degree*C*, +temperature_max_12,temperature_max_12,WorldClim_2.1_EC-Earth3-Veg_ssp126_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Dec,max T Dec,december,degrees Celsius,*degree*C*, +bio01,bio01,WorldClim_2.1_EC-Earth3-Veg_ssp126_5m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual mean temperature,ann. mean T,year,degrees Celsius,*degree*C*, +bio02,bio02,WorldClim_2.1_EC-Earth3-Veg_ssp126_5m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean diurnal range,diurn. range,year,degrees Celsius,*degree*C*, +bio03,bio03,WorldClim_2.1_EC-Earth3-Veg_ssp126_5m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,isothermality,isothermality,year,,, +bio04,bio04,WorldClim_2.1_EC-Earth3-Veg_ssp126_5m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature seasonality,T season.,year,degrees Celsius,*degree*C*, +bio05,bio05,WorldClim_2.1_EC-Earth3-Veg_ssp126_5m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature of warmest month,max. T of warmest mo.,year,degrees Celsius,*degree*C*, +bio06,bio06,WorldClim_2.1_EC-Earth3-Veg_ssp126_5m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature of coldest month,min. T of coldest mo.,year,degrees Celsius,*degree*C*, +bio07,bio07,WorldClim_2.1_EC-Earth3-Veg_ssp126_5m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature annual range (bio05-bio06),T ann. Range,year,degrees Celsius,*degree*C*, +bio08,bio08,WorldClim_2.1_EC-Earth3-Veg_ssp126_5m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of wettest quarter,mean T of wettest qtr,year,degrees Celsius,*degree*C*, +bio09,bio09,WorldClim_2.1_EC-Earth3-Veg_ssp126_5m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of driest quarter,mean T of driest qtr,year,degrees Celsius,*degree*C*, +bio10,bio10,WorldClim_2.1_EC-Earth3-Veg_ssp126_5m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of warmest quarter,mean T of warmest qtr,year,degrees Celsius,*degree*C*, +bio11,bio11,WorldClim_2.1_EC-Earth3-Veg_ssp126_5m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of coldest quarter,mean T of coldest qtr,year,degrees Celsius,*degree*C*, +bio12,bio12,WorldClim_2.1_EC-Earth3-Veg_ssp126_5m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual precipitation,ann. P,year,mm per year,*mm~yr^-1*, +bio13,bio13,WorldClim_2.1_EC-Earth3-Veg_ssp126_5m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest month,P of wettest mo.,year,mm per month,*mm~mo^-1*, +bio14,bio14,WorldClim_2.1_EC-Earth3-Veg_ssp126_5m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest month,P of driest mo.,year,mm per month,*mm~mo^-1*, +bio15,bio15,WorldClim_2.1_EC-Earth3-Veg_ssp126_5m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation seasonality (coeff var),P season.,year,,, +bio16,bio16,WorldClim_2.1_EC-Earth3-Veg_ssp126_5m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest quarter,P of wettest qtr,year,mm per quarter,*mm~qtr^-1*, +bio17,bio17,WorldClim_2.1_EC-Earth3-Veg_ssp126_5m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest quarter,P of driest qtr,year,mm per quarter,*mm~qtr^-1*, +bio18,bio18,WorldClim_2.1_EC-Earth3-Veg_ssp126_5m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of warmest quarter,P of warmest qtr,year,mm per quarter,*mm~qtr^-1*, +bio19,bio19,WorldClim_2.1_EC-Earth3-Veg_ssp126_5m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of coldest quarter,P of coldest qtr,year,mm per quarter,*mm~qtr^-1*, +precipitation_01,precipitation_01,WorldClim_2.1_EC-Earth3-Veg_ssp126_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jan,P Jan,january,mm per month,*mm~mo^-1*, +precipitation_02,precipitation_02,WorldClim_2.1_EC-Earth3-Veg_ssp126_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Feb,P Feb,february,mm per month,*mm~mo^-1*, +precipitation_03,precipitation_03,WorldClim_2.1_EC-Earth3-Veg_ssp126_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Mar,P Mar,march,mm per month,*mm~mo^-1*, +precipitation_04,precipitation_04,WorldClim_2.1_EC-Earth3-Veg_ssp126_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Apr,P Apr,april,mm per month,*mm~mo^-1*, +precipitation_05,precipitation_05,WorldClim_2.1_EC-Earth3-Veg_ssp126_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation May,P May,may,mm per month,*mm~mo^-1*, +precipitation_06,precipitation_06,WorldClim_2.1_EC-Earth3-Veg_ssp126_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jun,P Jun,june,mm per month,*mm~mo^-1*, +precipitation_07,precipitation_07,WorldClim_2.1_EC-Earth3-Veg_ssp126_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jul,P Jul,july,mm per month,*mm~mo^-1*, +precipitation_08,precipitation_08,WorldClim_2.1_EC-Earth3-Veg_ssp126_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Aug,P Aug,august,mm per month,*mm~mo^-1*, +precipitation_09,precipitation_09,WorldClim_2.1_EC-Earth3-Veg_ssp126_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Sep,P Sep,september,mm per month,*mm~mo^-1*, +precipitation_10,precipitation_10,WorldClim_2.1_EC-Earth3-Veg_ssp126_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Oct,P Oct,october,mm per month,*mm~mo^-1*, +precipitation_11,precipitation_11,WorldClim_2.1_EC-Earth3-Veg_ssp126_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Nov,P Nov,november,mm per month,*mm~mo^-1*, +precipitation_12,precipitation_12,WorldClim_2.1_EC-Earth3-Veg_ssp126_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Dec,P Dec,december,mm per month,*mm~mo^-1*, +temperature_min_01,temperature_min_01,WorldClim_2.1_EC-Earth3-Veg_ssp126_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jan,min T Jan,january,degrees Celsius,*degree*C*, +temperature_min_02,temperature_min_02,WorldClim_2.1_EC-Earth3-Veg_ssp126_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Feb,min T Feb,february,degrees Celsius,*degree*C*, +temperature_min_03,temperature_min_03,WorldClim_2.1_EC-Earth3-Veg_ssp126_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Mar,min T Mar,march,degrees Celsius,*degree*C*, +temperature_min_04,temperature_min_04,WorldClim_2.1_EC-Earth3-Veg_ssp126_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Apr,min T Apr,april,degrees Celsius,*degree*C*, +temperature_min_05,temperature_min_05,WorldClim_2.1_EC-Earth3-Veg_ssp126_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature May,min T May,may,degrees Celsius,*degree*C*, +temperature_min_06,temperature_min_06,WorldClim_2.1_EC-Earth3-Veg_ssp126_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jun,min T Jun,june,degrees Celsius,*degree*C*, +temperature_min_07,temperature_min_07,WorldClim_2.1_EC-Earth3-Veg_ssp126_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jul,min T Jul,july,degrees Celsius,*degree*C*, +temperature_min_08,temperature_min_08,WorldClim_2.1_EC-Earth3-Veg_ssp126_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Aug,min T Aug,august,degrees Celsius,*degree*C*, +temperature_min_09,temperature_min_09,WorldClim_2.1_EC-Earth3-Veg_ssp126_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Sep,min T Sep,september,degrees Celsius,*degree*C*, +temperature_min_10,temperature_min_10,WorldClim_2.1_EC-Earth3-Veg_ssp126_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Oct,min T Oct,october,degrees Celsius,*degree*C*, +temperature_min_11,temperature_min_11,WorldClim_2.1_EC-Earth3-Veg_ssp126_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Nov,min T Nov,november,degrees Celsius,*degree*C*, +temperature_min_12,temperature_min_12,WorldClim_2.1_EC-Earth3-Veg_ssp126_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Dec,min T Dec,december,degrees Celsius,*degree*C*, +temperature_max_01,temperature_max_01,WorldClim_2.1_EC-Earth3-Veg_ssp126_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jan,max T Jan,january,degrees Celsius,*degree*C*, +temperature_max_02,temperature_max_02,WorldClim_2.1_EC-Earth3-Veg_ssp126_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Feb,max T Feb,february,degrees Celsius,*degree*C*, +temperature_max_03,temperature_max_03,WorldClim_2.1_EC-Earth3-Veg_ssp126_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Mar,max T Mar,march,degrees Celsius,*degree*C*, +temperature_max_04,temperature_max_04,WorldClim_2.1_EC-Earth3-Veg_ssp126_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Apr,max T Apr,april,degrees Celsius,*degree*C*, +temperature_max_05,temperature_max_05,WorldClim_2.1_EC-Earth3-Veg_ssp126_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature May,max T May,may,degrees Celsius,*degree*C*, +temperature_max_06,temperature_max_06,WorldClim_2.1_EC-Earth3-Veg_ssp126_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jun,max T Jun,june,degrees Celsius,*degree*C*, +temperature_max_07,temperature_max_07,WorldClim_2.1_EC-Earth3-Veg_ssp126_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jul,max T Jul,july,degrees Celsius,*degree*C*, +temperature_max_08,temperature_max_08,WorldClim_2.1_EC-Earth3-Veg_ssp126_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Aug,max T Aug,august,degrees Celsius,*degree*C*, +temperature_max_09,temperature_max_09,WorldClim_2.1_EC-Earth3-Veg_ssp126_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Sep,max T Sep,september,degrees Celsius,*degree*C*, +temperature_max_10,temperature_max_10,WorldClim_2.1_EC-Earth3-Veg_ssp126_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Oct,max T Oct,october,degrees Celsius,*degree*C*, +temperature_max_11,temperature_max_11,WorldClim_2.1_EC-Earth3-Veg_ssp126_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Nov,max T Nov,november,degrees Celsius,*degree*C*, +temperature_max_12,temperature_max_12,WorldClim_2.1_EC-Earth3-Veg_ssp126_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Dec,max T Dec,december,degrees Celsius,*degree*C*, +bio01,bio01,WorldClim_2.1_EC-Earth3-Veg_ssp245_10m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual mean temperature,ann. mean T,year,degrees Celsius,*degree*C*, +bio02,bio02,WorldClim_2.1_EC-Earth3-Veg_ssp245_10m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean diurnal range,diurn. range,year,degrees Celsius,*degree*C*, +bio03,bio03,WorldClim_2.1_EC-Earth3-Veg_ssp245_10m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,isothermality,isothermality,year,,, +bio04,bio04,WorldClim_2.1_EC-Earth3-Veg_ssp245_10m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature seasonality,T season.,year,degrees Celsius,*degree*C*, +bio05,bio05,WorldClim_2.1_EC-Earth3-Veg_ssp245_10m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature of warmest month,max. T of warmest mo.,year,degrees Celsius,*degree*C*, +bio06,bio06,WorldClim_2.1_EC-Earth3-Veg_ssp245_10m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature of coldest month,min. T of coldest mo.,year,degrees Celsius,*degree*C*, +bio07,bio07,WorldClim_2.1_EC-Earth3-Veg_ssp245_10m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature annual range (bio05-bio06),T ann. Range,year,degrees Celsius,*degree*C*, +bio08,bio08,WorldClim_2.1_EC-Earth3-Veg_ssp245_10m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of wettest quarter,mean T of wettest qtr,year,degrees Celsius,*degree*C*, +bio09,bio09,WorldClim_2.1_EC-Earth3-Veg_ssp245_10m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of driest quarter,mean T of driest qtr,year,degrees Celsius,*degree*C*, +bio10,bio10,WorldClim_2.1_EC-Earth3-Veg_ssp245_10m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of warmest quarter,mean T of warmest qtr,year,degrees Celsius,*degree*C*, +bio11,bio11,WorldClim_2.1_EC-Earth3-Veg_ssp245_10m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of coldest quarter,mean T of coldest qtr,year,degrees Celsius,*degree*C*, +bio12,bio12,WorldClim_2.1_EC-Earth3-Veg_ssp245_10m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual precipitation,ann. P,year,mm per year,*mm~yr^-1*, +bio13,bio13,WorldClim_2.1_EC-Earth3-Veg_ssp245_10m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest month,P of wettest mo.,year,mm per month,*mm~mo^-1*, +bio14,bio14,WorldClim_2.1_EC-Earth3-Veg_ssp245_10m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest month,P of driest mo.,year,mm per month,*mm~mo^-1*, +bio15,bio15,WorldClim_2.1_EC-Earth3-Veg_ssp245_10m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation seasonality (coeff var),P season.,year,,, +bio16,bio16,WorldClim_2.1_EC-Earth3-Veg_ssp245_10m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest quarter,P of wettest qtr,year,mm per quarter,*mm~qtr^-1*, +bio17,bio17,WorldClim_2.1_EC-Earth3-Veg_ssp245_10m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest quarter,P of driest qtr,year,mm per quarter,*mm~qtr^-1*, +bio18,bio18,WorldClim_2.1_EC-Earth3-Veg_ssp245_10m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of warmest quarter,P of warmest qtr,year,mm per quarter,*mm~qtr^-1*, +bio19,bio19,WorldClim_2.1_EC-Earth3-Veg_ssp245_10m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of coldest quarter,P of coldest qtr,year,mm per quarter,*mm~qtr^-1*, +precipitation_01,precipitation_01,WorldClim_2.1_EC-Earth3-Veg_ssp245_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jan,P Jan,january,mm per month,*mm~mo^-1*, +precipitation_02,precipitation_02,WorldClim_2.1_EC-Earth3-Veg_ssp245_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Feb,P Feb,february,mm per month,*mm~mo^-1*, +precipitation_03,precipitation_03,WorldClim_2.1_EC-Earth3-Veg_ssp245_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Mar,P Mar,march,mm per month,*mm~mo^-1*, +precipitation_04,precipitation_04,WorldClim_2.1_EC-Earth3-Veg_ssp245_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Apr,P Apr,april,mm per month,*mm~mo^-1*, +precipitation_05,precipitation_05,WorldClim_2.1_EC-Earth3-Veg_ssp245_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation May,P May,may,mm per month,*mm~mo^-1*, +precipitation_06,precipitation_06,WorldClim_2.1_EC-Earth3-Veg_ssp245_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jun,P Jun,june,mm per month,*mm~mo^-1*, +precipitation_07,precipitation_07,WorldClim_2.1_EC-Earth3-Veg_ssp245_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jul,P Jul,july,mm per month,*mm~mo^-1*, +precipitation_08,precipitation_08,WorldClim_2.1_EC-Earth3-Veg_ssp245_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Aug,P Aug,august,mm per month,*mm~mo^-1*, +precipitation_09,precipitation_09,WorldClim_2.1_EC-Earth3-Veg_ssp245_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Sep,P Sep,september,mm per month,*mm~mo^-1*, +precipitation_10,precipitation_10,WorldClim_2.1_EC-Earth3-Veg_ssp245_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Oct,P Oct,october,mm per month,*mm~mo^-1*, +precipitation_11,precipitation_11,WorldClim_2.1_EC-Earth3-Veg_ssp245_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Nov,P Nov,november,mm per month,*mm~mo^-1*, +precipitation_12,precipitation_12,WorldClim_2.1_EC-Earth3-Veg_ssp245_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Dec,P Dec,december,mm per month,*mm~mo^-1*, +temperature_min_01,temperature_min_01,WorldClim_2.1_EC-Earth3-Veg_ssp245_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jan,min T Jan,january,degrees Celsius,*degree*C*, +temperature_min_02,temperature_min_02,WorldClim_2.1_EC-Earth3-Veg_ssp245_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Feb,min T Feb,february,degrees Celsius,*degree*C*, +temperature_min_03,temperature_min_03,WorldClim_2.1_EC-Earth3-Veg_ssp245_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Mar,min T Mar,march,degrees Celsius,*degree*C*, +temperature_min_04,temperature_min_04,WorldClim_2.1_EC-Earth3-Veg_ssp245_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Apr,min T Apr,april,degrees Celsius,*degree*C*, +temperature_min_05,temperature_min_05,WorldClim_2.1_EC-Earth3-Veg_ssp245_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature May,min T May,may,degrees Celsius,*degree*C*, +temperature_min_06,temperature_min_06,WorldClim_2.1_EC-Earth3-Veg_ssp245_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jun,min T Jun,june,degrees Celsius,*degree*C*, +temperature_min_07,temperature_min_07,WorldClim_2.1_EC-Earth3-Veg_ssp245_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jul,min T Jul,july,degrees Celsius,*degree*C*, +temperature_min_08,temperature_min_08,WorldClim_2.1_EC-Earth3-Veg_ssp245_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Aug,min T Aug,august,degrees Celsius,*degree*C*, +temperature_min_09,temperature_min_09,WorldClim_2.1_EC-Earth3-Veg_ssp245_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Sep,min T Sep,september,degrees Celsius,*degree*C*, +temperature_min_10,temperature_min_10,WorldClim_2.1_EC-Earth3-Veg_ssp245_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Oct,min T Oct,october,degrees Celsius,*degree*C*, +temperature_min_11,temperature_min_11,WorldClim_2.1_EC-Earth3-Veg_ssp245_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Nov,min T Nov,november,degrees Celsius,*degree*C*, +temperature_min_12,temperature_min_12,WorldClim_2.1_EC-Earth3-Veg_ssp245_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Dec,min T Dec,december,degrees Celsius,*degree*C*, +temperature_max_01,temperature_max_01,WorldClim_2.1_EC-Earth3-Veg_ssp245_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jan,max T Jan,january,degrees Celsius,*degree*C*, +temperature_max_02,temperature_max_02,WorldClim_2.1_EC-Earth3-Veg_ssp245_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Feb,max T Feb,february,degrees Celsius,*degree*C*, +temperature_max_03,temperature_max_03,WorldClim_2.1_EC-Earth3-Veg_ssp245_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Mar,max T Mar,march,degrees Celsius,*degree*C*, +temperature_max_04,temperature_max_04,WorldClim_2.1_EC-Earth3-Veg_ssp245_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Apr,max T Apr,april,degrees Celsius,*degree*C*, +temperature_max_05,temperature_max_05,WorldClim_2.1_EC-Earth3-Veg_ssp245_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature May,max T May,may,degrees Celsius,*degree*C*, +temperature_max_06,temperature_max_06,WorldClim_2.1_EC-Earth3-Veg_ssp245_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jun,max T Jun,june,degrees Celsius,*degree*C*, +temperature_max_07,temperature_max_07,WorldClim_2.1_EC-Earth3-Veg_ssp245_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jul,max T Jul,july,degrees Celsius,*degree*C*, +temperature_max_08,temperature_max_08,WorldClim_2.1_EC-Earth3-Veg_ssp245_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Aug,max T Aug,august,degrees Celsius,*degree*C*, +temperature_max_09,temperature_max_09,WorldClim_2.1_EC-Earth3-Veg_ssp245_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Sep,max T Sep,september,degrees Celsius,*degree*C*, +temperature_max_10,temperature_max_10,WorldClim_2.1_EC-Earth3-Veg_ssp245_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Oct,max T Oct,october,degrees Celsius,*degree*C*, +temperature_max_11,temperature_max_11,WorldClim_2.1_EC-Earth3-Veg_ssp245_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Nov,max T Nov,november,degrees Celsius,*degree*C*, +temperature_max_12,temperature_max_12,WorldClim_2.1_EC-Earth3-Veg_ssp245_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Dec,max T Dec,december,degrees Celsius,*degree*C*, +bio01,bio01,WorldClim_2.1_EC-Earth3-Veg_ssp245_5m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual mean temperature,ann. mean T,year,degrees Celsius,*degree*C*, +bio02,bio02,WorldClim_2.1_EC-Earth3-Veg_ssp245_5m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean diurnal range,diurn. range,year,degrees Celsius,*degree*C*, +bio03,bio03,WorldClim_2.1_EC-Earth3-Veg_ssp245_5m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,isothermality,isothermality,year,,, +bio04,bio04,WorldClim_2.1_EC-Earth3-Veg_ssp245_5m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature seasonality,T season.,year,degrees Celsius,*degree*C*, +bio05,bio05,WorldClim_2.1_EC-Earth3-Veg_ssp245_5m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature of warmest month,max. T of warmest mo.,year,degrees Celsius,*degree*C*, +bio06,bio06,WorldClim_2.1_EC-Earth3-Veg_ssp245_5m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature of coldest month,min. T of coldest mo.,year,degrees Celsius,*degree*C*, +bio07,bio07,WorldClim_2.1_EC-Earth3-Veg_ssp245_5m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature annual range (bio05-bio06),T ann. Range,year,degrees Celsius,*degree*C*, +bio08,bio08,WorldClim_2.1_EC-Earth3-Veg_ssp245_5m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of wettest quarter,mean T of wettest qtr,year,degrees Celsius,*degree*C*, +bio09,bio09,WorldClim_2.1_EC-Earth3-Veg_ssp245_5m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of driest quarter,mean T of driest qtr,year,degrees Celsius,*degree*C*, +bio10,bio10,WorldClim_2.1_EC-Earth3-Veg_ssp245_5m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of warmest quarter,mean T of warmest qtr,year,degrees Celsius,*degree*C*, +bio11,bio11,WorldClim_2.1_EC-Earth3-Veg_ssp245_5m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of coldest quarter,mean T of coldest qtr,year,degrees Celsius,*degree*C*, +bio12,bio12,WorldClim_2.1_EC-Earth3-Veg_ssp245_5m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual precipitation,ann. P,year,mm per year,*mm~yr^-1*, +bio13,bio13,WorldClim_2.1_EC-Earth3-Veg_ssp245_5m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest month,P of wettest mo.,year,mm per month,*mm~mo^-1*, +bio14,bio14,WorldClim_2.1_EC-Earth3-Veg_ssp245_5m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest month,P of driest mo.,year,mm per month,*mm~mo^-1*, +bio15,bio15,WorldClim_2.1_EC-Earth3-Veg_ssp245_5m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation seasonality (coeff var),P season.,year,,, +bio16,bio16,WorldClim_2.1_EC-Earth3-Veg_ssp245_5m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest quarter,P of wettest qtr,year,mm per quarter,*mm~qtr^-1*, +bio17,bio17,WorldClim_2.1_EC-Earth3-Veg_ssp245_5m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest quarter,P of driest qtr,year,mm per quarter,*mm~qtr^-1*, +bio18,bio18,WorldClim_2.1_EC-Earth3-Veg_ssp245_5m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of warmest quarter,P of warmest qtr,year,mm per quarter,*mm~qtr^-1*, +bio19,bio19,WorldClim_2.1_EC-Earth3-Veg_ssp245_5m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of coldest quarter,P of coldest qtr,year,mm per quarter,*mm~qtr^-1*, +precipitation_01,precipitation_01,WorldClim_2.1_EC-Earth3-Veg_ssp245_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jan,P Jan,january,mm per month,*mm~mo^-1*, +precipitation_02,precipitation_02,WorldClim_2.1_EC-Earth3-Veg_ssp245_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Feb,P Feb,february,mm per month,*mm~mo^-1*, +precipitation_03,precipitation_03,WorldClim_2.1_EC-Earth3-Veg_ssp245_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Mar,P Mar,march,mm per month,*mm~mo^-1*, +precipitation_04,precipitation_04,WorldClim_2.1_EC-Earth3-Veg_ssp245_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Apr,P Apr,april,mm per month,*mm~mo^-1*, +precipitation_05,precipitation_05,WorldClim_2.1_EC-Earth3-Veg_ssp245_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation May,P May,may,mm per month,*mm~mo^-1*, +precipitation_06,precipitation_06,WorldClim_2.1_EC-Earth3-Veg_ssp245_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jun,P Jun,june,mm per month,*mm~mo^-1*, +precipitation_07,precipitation_07,WorldClim_2.1_EC-Earth3-Veg_ssp245_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jul,P Jul,july,mm per month,*mm~mo^-1*, +precipitation_08,precipitation_08,WorldClim_2.1_EC-Earth3-Veg_ssp245_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Aug,P Aug,august,mm per month,*mm~mo^-1*, +precipitation_09,precipitation_09,WorldClim_2.1_EC-Earth3-Veg_ssp245_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Sep,P Sep,september,mm per month,*mm~mo^-1*, +precipitation_10,precipitation_10,WorldClim_2.1_EC-Earth3-Veg_ssp245_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Oct,P Oct,october,mm per month,*mm~mo^-1*, +precipitation_11,precipitation_11,WorldClim_2.1_EC-Earth3-Veg_ssp245_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Nov,P Nov,november,mm per month,*mm~mo^-1*, +precipitation_12,precipitation_12,WorldClim_2.1_EC-Earth3-Veg_ssp245_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Dec,P Dec,december,mm per month,*mm~mo^-1*, +temperature_min_01,temperature_min_01,WorldClim_2.1_EC-Earth3-Veg_ssp245_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jan,min T Jan,january,degrees Celsius,*degree*C*, +temperature_min_02,temperature_min_02,WorldClim_2.1_EC-Earth3-Veg_ssp245_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Feb,min T Feb,february,degrees Celsius,*degree*C*, +temperature_min_03,temperature_min_03,WorldClim_2.1_EC-Earth3-Veg_ssp245_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Mar,min T Mar,march,degrees Celsius,*degree*C*, +temperature_min_04,temperature_min_04,WorldClim_2.1_EC-Earth3-Veg_ssp245_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Apr,min T Apr,april,degrees Celsius,*degree*C*, +temperature_min_05,temperature_min_05,WorldClim_2.1_EC-Earth3-Veg_ssp245_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature May,min T May,may,degrees Celsius,*degree*C*, +temperature_min_06,temperature_min_06,WorldClim_2.1_EC-Earth3-Veg_ssp245_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jun,min T Jun,june,degrees Celsius,*degree*C*, +temperature_min_07,temperature_min_07,WorldClim_2.1_EC-Earth3-Veg_ssp245_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jul,min T Jul,july,degrees Celsius,*degree*C*, +temperature_min_08,temperature_min_08,WorldClim_2.1_EC-Earth3-Veg_ssp245_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Aug,min T Aug,august,degrees Celsius,*degree*C*, +temperature_min_09,temperature_min_09,WorldClim_2.1_EC-Earth3-Veg_ssp245_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Sep,min T Sep,september,degrees Celsius,*degree*C*, +temperature_min_10,temperature_min_10,WorldClim_2.1_EC-Earth3-Veg_ssp245_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Oct,min T Oct,october,degrees Celsius,*degree*C*, +temperature_min_11,temperature_min_11,WorldClim_2.1_EC-Earth3-Veg_ssp245_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Nov,min T Nov,november,degrees Celsius,*degree*C*, +temperature_min_12,temperature_min_12,WorldClim_2.1_EC-Earth3-Veg_ssp245_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Dec,min T Dec,december,degrees Celsius,*degree*C*, +temperature_max_01,temperature_max_01,WorldClim_2.1_EC-Earth3-Veg_ssp245_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jan,max T Jan,january,degrees Celsius,*degree*C*, +temperature_max_02,temperature_max_02,WorldClim_2.1_EC-Earth3-Veg_ssp245_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Feb,max T Feb,february,degrees Celsius,*degree*C*, +temperature_max_03,temperature_max_03,WorldClim_2.1_EC-Earth3-Veg_ssp245_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Mar,max T Mar,march,degrees Celsius,*degree*C*, +temperature_max_04,temperature_max_04,WorldClim_2.1_EC-Earth3-Veg_ssp245_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Apr,max T Apr,april,degrees Celsius,*degree*C*, +temperature_max_05,temperature_max_05,WorldClim_2.1_EC-Earth3-Veg_ssp245_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature May,max T May,may,degrees Celsius,*degree*C*, +temperature_max_06,temperature_max_06,WorldClim_2.1_EC-Earth3-Veg_ssp245_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jun,max T Jun,june,degrees Celsius,*degree*C*, +temperature_max_07,temperature_max_07,WorldClim_2.1_EC-Earth3-Veg_ssp245_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jul,max T Jul,july,degrees Celsius,*degree*C*, +temperature_max_08,temperature_max_08,WorldClim_2.1_EC-Earth3-Veg_ssp245_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Aug,max T Aug,august,degrees Celsius,*degree*C*, +temperature_max_09,temperature_max_09,WorldClim_2.1_EC-Earth3-Veg_ssp245_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Sep,max T Sep,september,degrees Celsius,*degree*C*, +temperature_max_10,temperature_max_10,WorldClim_2.1_EC-Earth3-Veg_ssp245_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Oct,max T Oct,october,degrees Celsius,*degree*C*, +temperature_max_11,temperature_max_11,WorldClim_2.1_EC-Earth3-Veg_ssp245_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Nov,max T Nov,november,degrees Celsius,*degree*C*, +temperature_max_12,temperature_max_12,WorldClim_2.1_EC-Earth3-Veg_ssp245_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Dec,max T Dec,december,degrees Celsius,*degree*C*, +bio01,bio01,WorldClim_2.1_EC-Earth3-Veg_ssp370_10m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual mean temperature,ann. mean T,year,degrees Celsius,*degree*C*, +bio02,bio02,WorldClim_2.1_EC-Earth3-Veg_ssp370_10m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean diurnal range,diurn. range,year,degrees Celsius,*degree*C*, +bio03,bio03,WorldClim_2.1_EC-Earth3-Veg_ssp370_10m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,isothermality,isothermality,year,,, +bio04,bio04,WorldClim_2.1_EC-Earth3-Veg_ssp370_10m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature seasonality,T season.,year,degrees Celsius,*degree*C*, +bio05,bio05,WorldClim_2.1_EC-Earth3-Veg_ssp370_10m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature of warmest month,max. T of warmest mo.,year,degrees Celsius,*degree*C*, +bio06,bio06,WorldClim_2.1_EC-Earth3-Veg_ssp370_10m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature of coldest month,min. T of coldest mo.,year,degrees Celsius,*degree*C*, +bio07,bio07,WorldClim_2.1_EC-Earth3-Veg_ssp370_10m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature annual range (bio05-bio06),T ann. Range,year,degrees Celsius,*degree*C*, +bio08,bio08,WorldClim_2.1_EC-Earth3-Veg_ssp370_10m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of wettest quarter,mean T of wettest qtr,year,degrees Celsius,*degree*C*, +bio09,bio09,WorldClim_2.1_EC-Earth3-Veg_ssp370_10m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of driest quarter,mean T of driest qtr,year,degrees Celsius,*degree*C*, +bio10,bio10,WorldClim_2.1_EC-Earth3-Veg_ssp370_10m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of warmest quarter,mean T of warmest qtr,year,degrees Celsius,*degree*C*, +bio11,bio11,WorldClim_2.1_EC-Earth3-Veg_ssp370_10m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of coldest quarter,mean T of coldest qtr,year,degrees Celsius,*degree*C*, +bio12,bio12,WorldClim_2.1_EC-Earth3-Veg_ssp370_10m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual precipitation,ann. P,year,mm per year,*mm~yr^-1*, +bio13,bio13,WorldClim_2.1_EC-Earth3-Veg_ssp370_10m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest month,P of wettest mo.,year,mm per month,*mm~mo^-1*, +bio14,bio14,WorldClim_2.1_EC-Earth3-Veg_ssp370_10m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest month,P of driest mo.,year,mm per month,*mm~mo^-1*, +bio15,bio15,WorldClim_2.1_EC-Earth3-Veg_ssp370_10m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation seasonality (coeff var),P season.,year,,, +bio16,bio16,WorldClim_2.1_EC-Earth3-Veg_ssp370_10m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest quarter,P of wettest qtr,year,mm per quarter,*mm~qtr^-1*, +bio17,bio17,WorldClim_2.1_EC-Earth3-Veg_ssp370_10m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest quarter,P of driest qtr,year,mm per quarter,*mm~qtr^-1*, +bio18,bio18,WorldClim_2.1_EC-Earth3-Veg_ssp370_10m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of warmest quarter,P of warmest qtr,year,mm per quarter,*mm~qtr^-1*, +bio19,bio19,WorldClim_2.1_EC-Earth3-Veg_ssp370_10m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of coldest quarter,P of coldest qtr,year,mm per quarter,*mm~qtr^-1*, +precipitation_01,precipitation_01,WorldClim_2.1_EC-Earth3-Veg_ssp370_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jan,P Jan,january,mm per month,*mm~mo^-1*, +precipitation_02,precipitation_02,WorldClim_2.1_EC-Earth3-Veg_ssp370_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Feb,P Feb,february,mm per month,*mm~mo^-1*, +precipitation_03,precipitation_03,WorldClim_2.1_EC-Earth3-Veg_ssp370_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Mar,P Mar,march,mm per month,*mm~mo^-1*, +precipitation_04,precipitation_04,WorldClim_2.1_EC-Earth3-Veg_ssp370_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Apr,P Apr,april,mm per month,*mm~mo^-1*, +precipitation_05,precipitation_05,WorldClim_2.1_EC-Earth3-Veg_ssp370_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation May,P May,may,mm per month,*mm~mo^-1*, +precipitation_06,precipitation_06,WorldClim_2.1_EC-Earth3-Veg_ssp370_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jun,P Jun,june,mm per month,*mm~mo^-1*, +precipitation_07,precipitation_07,WorldClim_2.1_EC-Earth3-Veg_ssp370_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jul,P Jul,july,mm per month,*mm~mo^-1*, +precipitation_08,precipitation_08,WorldClim_2.1_EC-Earth3-Veg_ssp370_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Aug,P Aug,august,mm per month,*mm~mo^-1*, +precipitation_09,precipitation_09,WorldClim_2.1_EC-Earth3-Veg_ssp370_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Sep,P Sep,september,mm per month,*mm~mo^-1*, +precipitation_10,precipitation_10,WorldClim_2.1_EC-Earth3-Veg_ssp370_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Oct,P Oct,october,mm per month,*mm~mo^-1*, +precipitation_11,precipitation_11,WorldClim_2.1_EC-Earth3-Veg_ssp370_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Nov,P Nov,november,mm per month,*mm~mo^-1*, +precipitation_12,precipitation_12,WorldClim_2.1_EC-Earth3-Veg_ssp370_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Dec,P Dec,december,mm per month,*mm~mo^-1*, +temperature_min_01,temperature_min_01,WorldClim_2.1_EC-Earth3-Veg_ssp370_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jan,min T Jan,january,degrees Celsius,*degree*C*, +temperature_min_02,temperature_min_02,WorldClim_2.1_EC-Earth3-Veg_ssp370_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Feb,min T Feb,february,degrees Celsius,*degree*C*, +temperature_min_03,temperature_min_03,WorldClim_2.1_EC-Earth3-Veg_ssp370_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Mar,min T Mar,march,degrees Celsius,*degree*C*, +temperature_min_04,temperature_min_04,WorldClim_2.1_EC-Earth3-Veg_ssp370_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Apr,min T Apr,april,degrees Celsius,*degree*C*, +temperature_min_05,temperature_min_05,WorldClim_2.1_EC-Earth3-Veg_ssp370_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature May,min T May,may,degrees Celsius,*degree*C*, +temperature_min_06,temperature_min_06,WorldClim_2.1_EC-Earth3-Veg_ssp370_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jun,min T Jun,june,degrees Celsius,*degree*C*, +temperature_min_07,temperature_min_07,WorldClim_2.1_EC-Earth3-Veg_ssp370_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jul,min T Jul,july,degrees Celsius,*degree*C*, +temperature_min_08,temperature_min_08,WorldClim_2.1_EC-Earth3-Veg_ssp370_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Aug,min T Aug,august,degrees Celsius,*degree*C*, +temperature_min_09,temperature_min_09,WorldClim_2.1_EC-Earth3-Veg_ssp370_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Sep,min T Sep,september,degrees Celsius,*degree*C*, +temperature_min_10,temperature_min_10,WorldClim_2.1_EC-Earth3-Veg_ssp370_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Oct,min T Oct,october,degrees Celsius,*degree*C*, +temperature_min_11,temperature_min_11,WorldClim_2.1_EC-Earth3-Veg_ssp370_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Nov,min T Nov,november,degrees Celsius,*degree*C*, +temperature_min_12,temperature_min_12,WorldClim_2.1_EC-Earth3-Veg_ssp370_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Dec,min T Dec,december,degrees Celsius,*degree*C*, +temperature_max_01,temperature_max_01,WorldClim_2.1_EC-Earth3-Veg_ssp370_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jan,max T Jan,january,degrees Celsius,*degree*C*, +temperature_max_02,temperature_max_02,WorldClim_2.1_EC-Earth3-Veg_ssp370_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Feb,max T Feb,february,degrees Celsius,*degree*C*, +temperature_max_03,temperature_max_03,WorldClim_2.1_EC-Earth3-Veg_ssp370_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Mar,max T Mar,march,degrees Celsius,*degree*C*, +temperature_max_04,temperature_max_04,WorldClim_2.1_EC-Earth3-Veg_ssp370_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Apr,max T Apr,april,degrees Celsius,*degree*C*, +temperature_max_05,temperature_max_05,WorldClim_2.1_EC-Earth3-Veg_ssp370_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature May,max T May,may,degrees Celsius,*degree*C*, +temperature_max_06,temperature_max_06,WorldClim_2.1_EC-Earth3-Veg_ssp370_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jun,max T Jun,june,degrees Celsius,*degree*C*, +temperature_max_07,temperature_max_07,WorldClim_2.1_EC-Earth3-Veg_ssp370_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jul,max T Jul,july,degrees Celsius,*degree*C*, +temperature_max_08,temperature_max_08,WorldClim_2.1_EC-Earth3-Veg_ssp370_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Aug,max T Aug,august,degrees Celsius,*degree*C*, +temperature_max_09,temperature_max_09,WorldClim_2.1_EC-Earth3-Veg_ssp370_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Sep,max T Sep,september,degrees Celsius,*degree*C*, +temperature_max_10,temperature_max_10,WorldClim_2.1_EC-Earth3-Veg_ssp370_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Oct,max T Oct,october,degrees Celsius,*degree*C*, +temperature_max_11,temperature_max_11,WorldClim_2.1_EC-Earth3-Veg_ssp370_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Nov,max T Nov,november,degrees Celsius,*degree*C*, +temperature_max_12,temperature_max_12,WorldClim_2.1_EC-Earth3-Veg_ssp370_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Dec,max T Dec,december,degrees Celsius,*degree*C*, +bio01,bio01,WorldClim_2.1_EC-Earth3-Veg_ssp370_5m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual mean temperature,ann. mean T,year,degrees Celsius,*degree*C*, +bio02,bio02,WorldClim_2.1_EC-Earth3-Veg_ssp370_5m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean diurnal range,diurn. range,year,degrees Celsius,*degree*C*, +bio03,bio03,WorldClim_2.1_EC-Earth3-Veg_ssp370_5m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,isothermality,isothermality,year,,, +bio04,bio04,WorldClim_2.1_EC-Earth3-Veg_ssp370_5m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature seasonality,T season.,year,degrees Celsius,*degree*C*, +bio05,bio05,WorldClim_2.1_EC-Earth3-Veg_ssp370_5m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature of warmest month,max. T of warmest mo.,year,degrees Celsius,*degree*C*, +bio06,bio06,WorldClim_2.1_EC-Earth3-Veg_ssp370_5m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature of coldest month,min. T of coldest mo.,year,degrees Celsius,*degree*C*, +bio07,bio07,WorldClim_2.1_EC-Earth3-Veg_ssp370_5m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature annual range (bio05-bio06),T ann. Range,year,degrees Celsius,*degree*C*, +bio08,bio08,WorldClim_2.1_EC-Earth3-Veg_ssp370_5m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of wettest quarter,mean T of wettest qtr,year,degrees Celsius,*degree*C*, +bio09,bio09,WorldClim_2.1_EC-Earth3-Veg_ssp370_5m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of driest quarter,mean T of driest qtr,year,degrees Celsius,*degree*C*, +bio10,bio10,WorldClim_2.1_EC-Earth3-Veg_ssp370_5m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of warmest quarter,mean T of warmest qtr,year,degrees Celsius,*degree*C*, +bio11,bio11,WorldClim_2.1_EC-Earth3-Veg_ssp370_5m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of coldest quarter,mean T of coldest qtr,year,degrees Celsius,*degree*C*, +bio12,bio12,WorldClim_2.1_EC-Earth3-Veg_ssp370_5m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual precipitation,ann. P,year,mm per year,*mm~yr^-1*, +bio13,bio13,WorldClim_2.1_EC-Earth3-Veg_ssp370_5m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest month,P of wettest mo.,year,mm per month,*mm~mo^-1*, +bio14,bio14,WorldClim_2.1_EC-Earth3-Veg_ssp370_5m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest month,P of driest mo.,year,mm per month,*mm~mo^-1*, +bio15,bio15,WorldClim_2.1_EC-Earth3-Veg_ssp370_5m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation seasonality (coeff var),P season.,year,,, +bio16,bio16,WorldClim_2.1_EC-Earth3-Veg_ssp370_5m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest quarter,P of wettest qtr,year,mm per quarter,*mm~qtr^-1*, +bio17,bio17,WorldClim_2.1_EC-Earth3-Veg_ssp370_5m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest quarter,P of driest qtr,year,mm per quarter,*mm~qtr^-1*, +bio18,bio18,WorldClim_2.1_EC-Earth3-Veg_ssp370_5m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of warmest quarter,P of warmest qtr,year,mm per quarter,*mm~qtr^-1*, +bio19,bio19,WorldClim_2.1_EC-Earth3-Veg_ssp370_5m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of coldest quarter,P of coldest qtr,year,mm per quarter,*mm~qtr^-1*, +precipitation_01,precipitation_01,WorldClim_2.1_EC-Earth3-Veg_ssp370_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jan,P Jan,january,mm per month,*mm~mo^-1*, +precipitation_02,precipitation_02,WorldClim_2.1_EC-Earth3-Veg_ssp370_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Feb,P Feb,february,mm per month,*mm~mo^-1*, +precipitation_03,precipitation_03,WorldClim_2.1_EC-Earth3-Veg_ssp370_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Mar,P Mar,march,mm per month,*mm~mo^-1*, +precipitation_04,precipitation_04,WorldClim_2.1_EC-Earth3-Veg_ssp370_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Apr,P Apr,april,mm per month,*mm~mo^-1*, +precipitation_05,precipitation_05,WorldClim_2.1_EC-Earth3-Veg_ssp370_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation May,P May,may,mm per month,*mm~mo^-1*, +precipitation_06,precipitation_06,WorldClim_2.1_EC-Earth3-Veg_ssp370_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jun,P Jun,june,mm per month,*mm~mo^-1*, +precipitation_07,precipitation_07,WorldClim_2.1_EC-Earth3-Veg_ssp370_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jul,P Jul,july,mm per month,*mm~mo^-1*, +precipitation_08,precipitation_08,WorldClim_2.1_EC-Earth3-Veg_ssp370_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Aug,P Aug,august,mm per month,*mm~mo^-1*, +precipitation_09,precipitation_09,WorldClim_2.1_EC-Earth3-Veg_ssp370_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Sep,P Sep,september,mm per month,*mm~mo^-1*, +precipitation_10,precipitation_10,WorldClim_2.1_EC-Earth3-Veg_ssp370_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Oct,P Oct,october,mm per month,*mm~mo^-1*, +precipitation_11,precipitation_11,WorldClim_2.1_EC-Earth3-Veg_ssp370_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Nov,P Nov,november,mm per month,*mm~mo^-1*, +precipitation_12,precipitation_12,WorldClim_2.1_EC-Earth3-Veg_ssp370_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Dec,P Dec,december,mm per month,*mm~mo^-1*, +temperature_min_01,temperature_min_01,WorldClim_2.1_EC-Earth3-Veg_ssp370_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jan,min T Jan,january,degrees Celsius,*degree*C*, +temperature_min_02,temperature_min_02,WorldClim_2.1_EC-Earth3-Veg_ssp370_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Feb,min T Feb,february,degrees Celsius,*degree*C*, +temperature_min_03,temperature_min_03,WorldClim_2.1_EC-Earth3-Veg_ssp370_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Mar,min T Mar,march,degrees Celsius,*degree*C*, +temperature_min_04,temperature_min_04,WorldClim_2.1_EC-Earth3-Veg_ssp370_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Apr,min T Apr,april,degrees Celsius,*degree*C*, +temperature_min_05,temperature_min_05,WorldClim_2.1_EC-Earth3-Veg_ssp370_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature May,min T May,may,degrees Celsius,*degree*C*, +temperature_min_06,temperature_min_06,WorldClim_2.1_EC-Earth3-Veg_ssp370_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jun,min T Jun,june,degrees Celsius,*degree*C*, +temperature_min_07,temperature_min_07,WorldClim_2.1_EC-Earth3-Veg_ssp370_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jul,min T Jul,july,degrees Celsius,*degree*C*, +temperature_min_08,temperature_min_08,WorldClim_2.1_EC-Earth3-Veg_ssp370_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Aug,min T Aug,august,degrees Celsius,*degree*C*, +temperature_min_09,temperature_min_09,WorldClim_2.1_EC-Earth3-Veg_ssp370_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Sep,min T Sep,september,degrees Celsius,*degree*C*, +temperature_min_10,temperature_min_10,WorldClim_2.1_EC-Earth3-Veg_ssp370_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Oct,min T Oct,october,degrees Celsius,*degree*C*, +temperature_min_11,temperature_min_11,WorldClim_2.1_EC-Earth3-Veg_ssp370_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Nov,min T Nov,november,degrees Celsius,*degree*C*, +temperature_min_12,temperature_min_12,WorldClim_2.1_EC-Earth3-Veg_ssp370_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Dec,min T Dec,december,degrees Celsius,*degree*C*, +temperature_max_01,temperature_max_01,WorldClim_2.1_EC-Earth3-Veg_ssp370_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jan,max T Jan,january,degrees Celsius,*degree*C*, +temperature_max_02,temperature_max_02,WorldClim_2.1_EC-Earth3-Veg_ssp370_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Feb,max T Feb,february,degrees Celsius,*degree*C*, +temperature_max_03,temperature_max_03,WorldClim_2.1_EC-Earth3-Veg_ssp370_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Mar,max T Mar,march,degrees Celsius,*degree*C*, +temperature_max_04,temperature_max_04,WorldClim_2.1_EC-Earth3-Veg_ssp370_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Apr,max T Apr,april,degrees Celsius,*degree*C*, +temperature_max_05,temperature_max_05,WorldClim_2.1_EC-Earth3-Veg_ssp370_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature May,max T May,may,degrees Celsius,*degree*C*, +temperature_max_06,temperature_max_06,WorldClim_2.1_EC-Earth3-Veg_ssp370_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jun,max T Jun,june,degrees Celsius,*degree*C*, +temperature_max_07,temperature_max_07,WorldClim_2.1_EC-Earth3-Veg_ssp370_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jul,max T Jul,july,degrees Celsius,*degree*C*, +temperature_max_08,temperature_max_08,WorldClim_2.1_EC-Earth3-Veg_ssp370_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Aug,max T Aug,august,degrees Celsius,*degree*C*, +temperature_max_09,temperature_max_09,WorldClim_2.1_EC-Earth3-Veg_ssp370_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Sep,max T Sep,september,degrees Celsius,*degree*C*, +temperature_max_10,temperature_max_10,WorldClim_2.1_EC-Earth3-Veg_ssp370_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Oct,max T Oct,october,degrees Celsius,*degree*C*, +temperature_max_11,temperature_max_11,WorldClim_2.1_EC-Earth3-Veg_ssp370_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Nov,max T Nov,november,degrees Celsius,*degree*C*, +temperature_max_12,temperature_max_12,WorldClim_2.1_EC-Earth3-Veg_ssp370_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Dec,max T Dec,december,degrees Celsius,*degree*C*, +bio01,bio01,WorldClim_2.1_EC-Earth3-Veg_ssp585_10m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual mean temperature,ann. mean T,year,degrees Celsius,*degree*C*, +bio02,bio02,WorldClim_2.1_EC-Earth3-Veg_ssp585_10m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean diurnal range,diurn. range,year,degrees Celsius,*degree*C*, +bio03,bio03,WorldClim_2.1_EC-Earth3-Veg_ssp585_10m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,isothermality,isothermality,year,,, +bio04,bio04,WorldClim_2.1_EC-Earth3-Veg_ssp585_10m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature seasonality,T season.,year,degrees Celsius,*degree*C*, +bio05,bio05,WorldClim_2.1_EC-Earth3-Veg_ssp585_10m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature of warmest month,max. T of warmest mo.,year,degrees Celsius,*degree*C*, +bio06,bio06,WorldClim_2.1_EC-Earth3-Veg_ssp585_10m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature of coldest month,min. T of coldest mo.,year,degrees Celsius,*degree*C*, +bio07,bio07,WorldClim_2.1_EC-Earth3-Veg_ssp585_10m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature annual range (bio05-bio06),T ann. Range,year,degrees Celsius,*degree*C*, +bio08,bio08,WorldClim_2.1_EC-Earth3-Veg_ssp585_10m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of wettest quarter,mean T of wettest qtr,year,degrees Celsius,*degree*C*, +bio09,bio09,WorldClim_2.1_EC-Earth3-Veg_ssp585_10m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of driest quarter,mean T of driest qtr,year,degrees Celsius,*degree*C*, +bio10,bio10,WorldClim_2.1_EC-Earth3-Veg_ssp585_10m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of warmest quarter,mean T of warmest qtr,year,degrees Celsius,*degree*C*, +bio11,bio11,WorldClim_2.1_EC-Earth3-Veg_ssp585_10m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of coldest quarter,mean T of coldest qtr,year,degrees Celsius,*degree*C*, +bio12,bio12,WorldClim_2.1_EC-Earth3-Veg_ssp585_10m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual precipitation,ann. P,year,mm per year,*mm~yr^-1*, +bio13,bio13,WorldClim_2.1_EC-Earth3-Veg_ssp585_10m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest month,P of wettest mo.,year,mm per month,*mm~mo^-1*, +bio14,bio14,WorldClim_2.1_EC-Earth3-Veg_ssp585_10m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest month,P of driest mo.,year,mm per month,*mm~mo^-1*, +bio15,bio15,WorldClim_2.1_EC-Earth3-Veg_ssp585_10m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation seasonality (coeff var),P season.,year,,, +bio16,bio16,WorldClim_2.1_EC-Earth3-Veg_ssp585_10m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest quarter,P of wettest qtr,year,mm per quarter,*mm~qtr^-1*, +bio17,bio17,WorldClim_2.1_EC-Earth3-Veg_ssp585_10m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest quarter,P of driest qtr,year,mm per quarter,*mm~qtr^-1*, +bio18,bio18,WorldClim_2.1_EC-Earth3-Veg_ssp585_10m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of warmest quarter,P of warmest qtr,year,mm per quarter,*mm~qtr^-1*, +bio19,bio19,WorldClim_2.1_EC-Earth3-Veg_ssp585_10m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of coldest quarter,P of coldest qtr,year,mm per quarter,*mm~qtr^-1*, +precipitation_01,precipitation_01,WorldClim_2.1_EC-Earth3-Veg_ssp585_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jan,P Jan,january,mm per month,*mm~mo^-1*, +precipitation_02,precipitation_02,WorldClim_2.1_EC-Earth3-Veg_ssp585_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Feb,P Feb,february,mm per month,*mm~mo^-1*, +precipitation_03,precipitation_03,WorldClim_2.1_EC-Earth3-Veg_ssp585_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Mar,P Mar,march,mm per month,*mm~mo^-1*, +precipitation_04,precipitation_04,WorldClim_2.1_EC-Earth3-Veg_ssp585_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Apr,P Apr,april,mm per month,*mm~mo^-1*, +precipitation_05,precipitation_05,WorldClim_2.1_EC-Earth3-Veg_ssp585_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation May,P May,may,mm per month,*mm~mo^-1*, +precipitation_06,precipitation_06,WorldClim_2.1_EC-Earth3-Veg_ssp585_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jun,P Jun,june,mm per month,*mm~mo^-1*, +precipitation_07,precipitation_07,WorldClim_2.1_EC-Earth3-Veg_ssp585_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jul,P Jul,july,mm per month,*mm~mo^-1*, +precipitation_08,precipitation_08,WorldClim_2.1_EC-Earth3-Veg_ssp585_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Aug,P Aug,august,mm per month,*mm~mo^-1*, +precipitation_09,precipitation_09,WorldClim_2.1_EC-Earth3-Veg_ssp585_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Sep,P Sep,september,mm per month,*mm~mo^-1*, +precipitation_10,precipitation_10,WorldClim_2.1_EC-Earth3-Veg_ssp585_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Oct,P Oct,october,mm per month,*mm~mo^-1*, +precipitation_11,precipitation_11,WorldClim_2.1_EC-Earth3-Veg_ssp585_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Nov,P Nov,november,mm per month,*mm~mo^-1*, +precipitation_12,precipitation_12,WorldClim_2.1_EC-Earth3-Veg_ssp585_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Dec,P Dec,december,mm per month,*mm~mo^-1*, +temperature_min_01,temperature_min_01,WorldClim_2.1_EC-Earth3-Veg_ssp585_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jan,min T Jan,january,degrees Celsius,*degree*C*, +temperature_min_02,temperature_min_02,WorldClim_2.1_EC-Earth3-Veg_ssp585_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Feb,min T Feb,february,degrees Celsius,*degree*C*, +temperature_min_03,temperature_min_03,WorldClim_2.1_EC-Earth3-Veg_ssp585_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Mar,min T Mar,march,degrees Celsius,*degree*C*, +temperature_min_04,temperature_min_04,WorldClim_2.1_EC-Earth3-Veg_ssp585_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Apr,min T Apr,april,degrees Celsius,*degree*C*, +temperature_min_05,temperature_min_05,WorldClim_2.1_EC-Earth3-Veg_ssp585_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature May,min T May,may,degrees Celsius,*degree*C*, +temperature_min_06,temperature_min_06,WorldClim_2.1_EC-Earth3-Veg_ssp585_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jun,min T Jun,june,degrees Celsius,*degree*C*, +temperature_min_07,temperature_min_07,WorldClim_2.1_EC-Earth3-Veg_ssp585_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jul,min T Jul,july,degrees Celsius,*degree*C*, +temperature_min_08,temperature_min_08,WorldClim_2.1_EC-Earth3-Veg_ssp585_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Aug,min T Aug,august,degrees Celsius,*degree*C*, +temperature_min_09,temperature_min_09,WorldClim_2.1_EC-Earth3-Veg_ssp585_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Sep,min T Sep,september,degrees Celsius,*degree*C*, +temperature_min_10,temperature_min_10,WorldClim_2.1_EC-Earth3-Veg_ssp585_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Oct,min T Oct,october,degrees Celsius,*degree*C*, +temperature_min_11,temperature_min_11,WorldClim_2.1_EC-Earth3-Veg_ssp585_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Nov,min T Nov,november,degrees Celsius,*degree*C*, +temperature_min_12,temperature_min_12,WorldClim_2.1_EC-Earth3-Veg_ssp585_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Dec,min T Dec,december,degrees Celsius,*degree*C*, +temperature_max_01,temperature_max_01,WorldClim_2.1_EC-Earth3-Veg_ssp585_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jan,max T Jan,january,degrees Celsius,*degree*C*, +temperature_max_02,temperature_max_02,WorldClim_2.1_EC-Earth3-Veg_ssp585_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Feb,max T Feb,february,degrees Celsius,*degree*C*, +temperature_max_03,temperature_max_03,WorldClim_2.1_EC-Earth3-Veg_ssp585_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Mar,max T Mar,march,degrees Celsius,*degree*C*, +temperature_max_04,temperature_max_04,WorldClim_2.1_EC-Earth3-Veg_ssp585_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Apr,max T Apr,april,degrees Celsius,*degree*C*, +temperature_max_05,temperature_max_05,WorldClim_2.1_EC-Earth3-Veg_ssp585_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature May,max T May,may,degrees Celsius,*degree*C*, +temperature_max_06,temperature_max_06,WorldClim_2.1_EC-Earth3-Veg_ssp585_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jun,max T Jun,june,degrees Celsius,*degree*C*, +temperature_max_07,temperature_max_07,WorldClim_2.1_EC-Earth3-Veg_ssp585_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jul,max T Jul,july,degrees Celsius,*degree*C*, +temperature_max_08,temperature_max_08,WorldClim_2.1_EC-Earth3-Veg_ssp585_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Aug,max T Aug,august,degrees Celsius,*degree*C*, +temperature_max_09,temperature_max_09,WorldClim_2.1_EC-Earth3-Veg_ssp585_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Sep,max T Sep,september,degrees Celsius,*degree*C*, +temperature_max_10,temperature_max_10,WorldClim_2.1_EC-Earth3-Veg_ssp585_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Oct,max T Oct,october,degrees Celsius,*degree*C*, +temperature_max_11,temperature_max_11,WorldClim_2.1_EC-Earth3-Veg_ssp585_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Nov,max T Nov,november,degrees Celsius,*degree*C*, +temperature_max_12,temperature_max_12,WorldClim_2.1_EC-Earth3-Veg_ssp585_10m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Dec,max T Dec,december,degrees Celsius,*degree*C*, +bio01,bio01,WorldClim_2.1_EC-Earth3-Veg_ssp585_5m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual mean temperature,ann. mean T,year,degrees Celsius,*degree*C*, +bio02,bio02,WorldClim_2.1_EC-Earth3-Veg_ssp585_5m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean diurnal range,diurn. range,year,degrees Celsius,*degree*C*, +bio03,bio03,WorldClim_2.1_EC-Earth3-Veg_ssp585_5m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,isothermality,isothermality,year,,, +bio04,bio04,WorldClim_2.1_EC-Earth3-Veg_ssp585_5m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature seasonality,T season.,year,degrees Celsius,*degree*C*, +bio05,bio05,WorldClim_2.1_EC-Earth3-Veg_ssp585_5m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature of warmest month,max. T of warmest mo.,year,degrees Celsius,*degree*C*, +bio06,bio06,WorldClim_2.1_EC-Earth3-Veg_ssp585_5m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature of coldest month,min. T of coldest mo.,year,degrees Celsius,*degree*C*, +bio07,bio07,WorldClim_2.1_EC-Earth3-Veg_ssp585_5m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature annual range (bio05-bio06),T ann. Range,year,degrees Celsius,*degree*C*, +bio08,bio08,WorldClim_2.1_EC-Earth3-Veg_ssp585_5m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of wettest quarter,mean T of wettest qtr,year,degrees Celsius,*degree*C*, +bio09,bio09,WorldClim_2.1_EC-Earth3-Veg_ssp585_5m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of driest quarter,mean T of driest qtr,year,degrees Celsius,*degree*C*, +bio10,bio10,WorldClim_2.1_EC-Earth3-Veg_ssp585_5m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of warmest quarter,mean T of warmest qtr,year,degrees Celsius,*degree*C*, +bio11,bio11,WorldClim_2.1_EC-Earth3-Veg_ssp585_5m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of coldest quarter,mean T of coldest qtr,year,degrees Celsius,*degree*C*, +bio12,bio12,WorldClim_2.1_EC-Earth3-Veg_ssp585_5m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual precipitation,ann. P,year,mm per year,*mm~yr^-1*, +bio13,bio13,WorldClim_2.1_EC-Earth3-Veg_ssp585_5m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest month,P of wettest mo.,year,mm per month,*mm~mo^-1*, +bio14,bio14,WorldClim_2.1_EC-Earth3-Veg_ssp585_5m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest month,P of driest mo.,year,mm per month,*mm~mo^-1*, +bio15,bio15,WorldClim_2.1_EC-Earth3-Veg_ssp585_5m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation seasonality (coeff var),P season.,year,,, +bio16,bio16,WorldClim_2.1_EC-Earth3-Veg_ssp585_5m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest quarter,P of wettest qtr,year,mm per quarter,*mm~qtr^-1*, +bio17,bio17,WorldClim_2.1_EC-Earth3-Veg_ssp585_5m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest quarter,P of driest qtr,year,mm per quarter,*mm~qtr^-1*, +bio18,bio18,WorldClim_2.1_EC-Earth3-Veg_ssp585_5m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of warmest quarter,P of warmest qtr,year,mm per quarter,*mm~qtr^-1*, +bio19,bio19,WorldClim_2.1_EC-Earth3-Veg_ssp585_5m,FALSE,WorldClim_2.1_EC-Earth3-Veg_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of coldest quarter,P of coldest qtr,year,mm per quarter,*mm~qtr^-1*, +precipitation_01,precipitation_01,WorldClim_2.1_EC-Earth3-Veg_ssp585_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jan,P Jan,january,mm per month,*mm~mo^-1*, +precipitation_02,precipitation_02,WorldClim_2.1_EC-Earth3-Veg_ssp585_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Feb,P Feb,february,mm per month,*mm~mo^-1*, +precipitation_03,precipitation_03,WorldClim_2.1_EC-Earth3-Veg_ssp585_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Mar,P Mar,march,mm per month,*mm~mo^-1*, +precipitation_04,precipitation_04,WorldClim_2.1_EC-Earth3-Veg_ssp585_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Apr,P Apr,april,mm per month,*mm~mo^-1*, +precipitation_05,precipitation_05,WorldClim_2.1_EC-Earth3-Veg_ssp585_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation May,P May,may,mm per month,*mm~mo^-1*, +precipitation_06,precipitation_06,WorldClim_2.1_EC-Earth3-Veg_ssp585_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jun,P Jun,june,mm per month,*mm~mo^-1*, +precipitation_07,precipitation_07,WorldClim_2.1_EC-Earth3-Veg_ssp585_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jul,P Jul,july,mm per month,*mm~mo^-1*, +precipitation_08,precipitation_08,WorldClim_2.1_EC-Earth3-Veg_ssp585_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Aug,P Aug,august,mm per month,*mm~mo^-1*, +precipitation_09,precipitation_09,WorldClim_2.1_EC-Earth3-Veg_ssp585_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Sep,P Sep,september,mm per month,*mm~mo^-1*, +precipitation_10,precipitation_10,WorldClim_2.1_EC-Earth3-Veg_ssp585_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Oct,P Oct,october,mm per month,*mm~mo^-1*, +precipitation_11,precipitation_11,WorldClim_2.1_EC-Earth3-Veg_ssp585_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Nov,P Nov,november,mm per month,*mm~mo^-1*, +precipitation_12,precipitation_12,WorldClim_2.1_EC-Earth3-Veg_ssp585_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Dec,P Dec,december,mm per month,*mm~mo^-1*, +temperature_min_01,temperature_min_01,WorldClim_2.1_EC-Earth3-Veg_ssp585_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jan,min T Jan,january,degrees Celsius,*degree*C*, +temperature_min_02,temperature_min_02,WorldClim_2.1_EC-Earth3-Veg_ssp585_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Feb,min T Feb,february,degrees Celsius,*degree*C*, +temperature_min_03,temperature_min_03,WorldClim_2.1_EC-Earth3-Veg_ssp585_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Mar,min T Mar,march,degrees Celsius,*degree*C*, +temperature_min_04,temperature_min_04,WorldClim_2.1_EC-Earth3-Veg_ssp585_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Apr,min T Apr,april,degrees Celsius,*degree*C*, +temperature_min_05,temperature_min_05,WorldClim_2.1_EC-Earth3-Veg_ssp585_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature May,min T May,may,degrees Celsius,*degree*C*, +temperature_min_06,temperature_min_06,WorldClim_2.1_EC-Earth3-Veg_ssp585_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jun,min T Jun,june,degrees Celsius,*degree*C*, +temperature_min_07,temperature_min_07,WorldClim_2.1_EC-Earth3-Veg_ssp585_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jul,min T Jul,july,degrees Celsius,*degree*C*, +temperature_min_08,temperature_min_08,WorldClim_2.1_EC-Earth3-Veg_ssp585_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Aug,min T Aug,august,degrees Celsius,*degree*C*, +temperature_min_09,temperature_min_09,WorldClim_2.1_EC-Earth3-Veg_ssp585_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Sep,min T Sep,september,degrees Celsius,*degree*C*, +temperature_min_10,temperature_min_10,WorldClim_2.1_EC-Earth3-Veg_ssp585_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Oct,min T Oct,october,degrees Celsius,*degree*C*, +temperature_min_11,temperature_min_11,WorldClim_2.1_EC-Earth3-Veg_ssp585_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Nov,min T Nov,november,degrees Celsius,*degree*C*, +temperature_min_12,temperature_min_12,WorldClim_2.1_EC-Earth3-Veg_ssp585_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Dec,min T Dec,december,degrees Celsius,*degree*C*, +temperature_max_01,temperature_max_01,WorldClim_2.1_EC-Earth3-Veg_ssp585_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jan,max T Jan,january,degrees Celsius,*degree*C*, +temperature_max_02,temperature_max_02,WorldClim_2.1_EC-Earth3-Veg_ssp585_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Feb,max T Feb,february,degrees Celsius,*degree*C*, +temperature_max_03,temperature_max_03,WorldClim_2.1_EC-Earth3-Veg_ssp585_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Mar,max T Mar,march,degrees Celsius,*degree*C*, +temperature_max_04,temperature_max_04,WorldClim_2.1_EC-Earth3-Veg_ssp585_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Apr,max T Apr,april,degrees Celsius,*degree*C*, +temperature_max_05,temperature_max_05,WorldClim_2.1_EC-Earth3-Veg_ssp585_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature May,max T May,may,degrees Celsius,*degree*C*, +temperature_max_06,temperature_max_06,WorldClim_2.1_EC-Earth3-Veg_ssp585_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jun,max T Jun,june,degrees Celsius,*degree*C*, +temperature_max_07,temperature_max_07,WorldClim_2.1_EC-Earth3-Veg_ssp585_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jul,max T Jul,july,degrees Celsius,*degree*C*, +temperature_max_08,temperature_max_08,WorldClim_2.1_EC-Earth3-Veg_ssp585_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Aug,max T Aug,august,degrees Celsius,*degree*C*, +temperature_max_09,temperature_max_09,WorldClim_2.1_EC-Earth3-Veg_ssp585_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Sep,max T Sep,september,degrees Celsius,*degree*C*, +temperature_max_10,temperature_max_10,WorldClim_2.1_EC-Earth3-Veg_ssp585_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Oct,max T Oct,october,degrees Celsius,*degree*C*, +temperature_max_11,temperature_max_11,WorldClim_2.1_EC-Earth3-Veg_ssp585_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Nov,max T Nov,november,degrees Celsius,*degree*C*, +temperature_max_12,temperature_max_12,WorldClim_2.1_EC-Earth3-Veg_ssp585_5m,TRUE,WorldClim_2.1_EC-Earth3-Veg_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Dec,max T Dec,december,degrees Celsius,*degree*C*, +bio01,bio01,WorldClim_2.1_FIO-ESM-2-0_ssp126_10m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual mean temperature,ann. mean T,year,degrees Celsius,*degree*C*, +bio02,bio02,WorldClim_2.1_FIO-ESM-2-0_ssp126_10m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean diurnal range,diurn. range,year,degrees Celsius,*degree*C*, +bio03,bio03,WorldClim_2.1_FIO-ESM-2-0_ssp126_10m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,isothermality,isothermality,year,,, +bio04,bio04,WorldClim_2.1_FIO-ESM-2-0_ssp126_10m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature seasonality,T season.,year,degrees Celsius,*degree*C*, +bio05,bio05,WorldClim_2.1_FIO-ESM-2-0_ssp126_10m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature of warmest month,max. T of warmest mo.,year,degrees Celsius,*degree*C*, +bio06,bio06,WorldClim_2.1_FIO-ESM-2-0_ssp126_10m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature of coldest month,min. T of coldest mo.,year,degrees Celsius,*degree*C*, +bio07,bio07,WorldClim_2.1_FIO-ESM-2-0_ssp126_10m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature annual range (bio05-bio06),T ann. Range,year,degrees Celsius,*degree*C*, +bio08,bio08,WorldClim_2.1_FIO-ESM-2-0_ssp126_10m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of wettest quarter,mean T of wettest qtr,year,degrees Celsius,*degree*C*, +bio09,bio09,WorldClim_2.1_FIO-ESM-2-0_ssp126_10m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of driest quarter,mean T of driest qtr,year,degrees Celsius,*degree*C*, +bio10,bio10,WorldClim_2.1_FIO-ESM-2-0_ssp126_10m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of warmest quarter,mean T of warmest qtr,year,degrees Celsius,*degree*C*, +bio11,bio11,WorldClim_2.1_FIO-ESM-2-0_ssp126_10m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of coldest quarter,mean T of coldest qtr,year,degrees Celsius,*degree*C*, +bio12,bio12,WorldClim_2.1_FIO-ESM-2-0_ssp126_10m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual precipitation,ann. P,year,mm per year,*mm~yr^-1*, +bio13,bio13,WorldClim_2.1_FIO-ESM-2-0_ssp126_10m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest month,P of wettest mo.,year,mm per month,*mm~mo^-1*, +bio14,bio14,WorldClim_2.1_FIO-ESM-2-0_ssp126_10m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest month,P of driest mo.,year,mm per month,*mm~mo^-1*, +bio15,bio15,WorldClim_2.1_FIO-ESM-2-0_ssp126_10m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation seasonality (coeff var),P season.,year,,, +bio16,bio16,WorldClim_2.1_FIO-ESM-2-0_ssp126_10m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest quarter,P of wettest qtr,year,mm per quarter,*mm~qtr^-1*, +bio17,bio17,WorldClim_2.1_FIO-ESM-2-0_ssp126_10m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest quarter,P of driest qtr,year,mm per quarter,*mm~qtr^-1*, +bio18,bio18,WorldClim_2.1_FIO-ESM-2-0_ssp126_10m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of warmest quarter,P of warmest qtr,year,mm per quarter,*mm~qtr^-1*, +bio19,bio19,WorldClim_2.1_FIO-ESM-2-0_ssp126_10m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of coldest quarter,P of coldest qtr,year,mm per quarter,*mm~qtr^-1*, +precipitation_01,precipitation_01,WorldClim_2.1_FIO-ESM-2-0_ssp126_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jan,P Jan,january,mm per month,*mm~mo^-1*, +precipitation_02,precipitation_02,WorldClim_2.1_FIO-ESM-2-0_ssp126_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Feb,P Feb,february,mm per month,*mm~mo^-1*, +precipitation_03,precipitation_03,WorldClim_2.1_FIO-ESM-2-0_ssp126_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Mar,P Mar,march,mm per month,*mm~mo^-1*, +precipitation_04,precipitation_04,WorldClim_2.1_FIO-ESM-2-0_ssp126_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Apr,P Apr,april,mm per month,*mm~mo^-1*, +precipitation_05,precipitation_05,WorldClim_2.1_FIO-ESM-2-0_ssp126_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation May,P May,may,mm per month,*mm~mo^-1*, +precipitation_06,precipitation_06,WorldClim_2.1_FIO-ESM-2-0_ssp126_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jun,P Jun,june,mm per month,*mm~mo^-1*, +precipitation_07,precipitation_07,WorldClim_2.1_FIO-ESM-2-0_ssp126_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jul,P Jul,july,mm per month,*mm~mo^-1*, +precipitation_08,precipitation_08,WorldClim_2.1_FIO-ESM-2-0_ssp126_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Aug,P Aug,august,mm per month,*mm~mo^-1*, +precipitation_09,precipitation_09,WorldClim_2.1_FIO-ESM-2-0_ssp126_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Sep,P Sep,september,mm per month,*mm~mo^-1*, +precipitation_10,precipitation_10,WorldClim_2.1_FIO-ESM-2-0_ssp126_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Oct,P Oct,october,mm per month,*mm~mo^-1*, +precipitation_11,precipitation_11,WorldClim_2.1_FIO-ESM-2-0_ssp126_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Nov,P Nov,november,mm per month,*mm~mo^-1*, +precipitation_12,precipitation_12,WorldClim_2.1_FIO-ESM-2-0_ssp126_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Dec,P Dec,december,mm per month,*mm~mo^-1*, +temperature_min_01,temperature_min_01,WorldClim_2.1_FIO-ESM-2-0_ssp126_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jan,min T Jan,january,degrees Celsius,*degree*C*, +temperature_min_02,temperature_min_02,WorldClim_2.1_FIO-ESM-2-0_ssp126_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Feb,min T Feb,february,degrees Celsius,*degree*C*, +temperature_min_03,temperature_min_03,WorldClim_2.1_FIO-ESM-2-0_ssp126_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Mar,min T Mar,march,degrees Celsius,*degree*C*, +temperature_min_04,temperature_min_04,WorldClim_2.1_FIO-ESM-2-0_ssp126_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Apr,min T Apr,april,degrees Celsius,*degree*C*, +temperature_min_05,temperature_min_05,WorldClim_2.1_FIO-ESM-2-0_ssp126_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature May,min T May,may,degrees Celsius,*degree*C*, +temperature_min_06,temperature_min_06,WorldClim_2.1_FIO-ESM-2-0_ssp126_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jun,min T Jun,june,degrees Celsius,*degree*C*, +temperature_min_07,temperature_min_07,WorldClim_2.1_FIO-ESM-2-0_ssp126_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jul,min T Jul,july,degrees Celsius,*degree*C*, +temperature_min_08,temperature_min_08,WorldClim_2.1_FIO-ESM-2-0_ssp126_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Aug,min T Aug,august,degrees Celsius,*degree*C*, +temperature_min_09,temperature_min_09,WorldClim_2.1_FIO-ESM-2-0_ssp126_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Sep,min T Sep,september,degrees Celsius,*degree*C*, +temperature_min_10,temperature_min_10,WorldClim_2.1_FIO-ESM-2-0_ssp126_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Oct,min T Oct,october,degrees Celsius,*degree*C*, +temperature_min_11,temperature_min_11,WorldClim_2.1_FIO-ESM-2-0_ssp126_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Nov,min T Nov,november,degrees Celsius,*degree*C*, +temperature_min_12,temperature_min_12,WorldClim_2.1_FIO-ESM-2-0_ssp126_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Dec,min T Dec,december,degrees Celsius,*degree*C*, +temperature_max_01,temperature_max_01,WorldClim_2.1_FIO-ESM-2-0_ssp126_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jan,max T Jan,january,degrees Celsius,*degree*C*, +temperature_max_02,temperature_max_02,WorldClim_2.1_FIO-ESM-2-0_ssp126_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Feb,max T Feb,february,degrees Celsius,*degree*C*, +temperature_max_03,temperature_max_03,WorldClim_2.1_FIO-ESM-2-0_ssp126_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Mar,max T Mar,march,degrees Celsius,*degree*C*, +temperature_max_04,temperature_max_04,WorldClim_2.1_FIO-ESM-2-0_ssp126_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Apr,max T Apr,april,degrees Celsius,*degree*C*, +temperature_max_05,temperature_max_05,WorldClim_2.1_FIO-ESM-2-0_ssp126_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature May,max T May,may,degrees Celsius,*degree*C*, +temperature_max_06,temperature_max_06,WorldClim_2.1_FIO-ESM-2-0_ssp126_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jun,max T Jun,june,degrees Celsius,*degree*C*, +temperature_max_07,temperature_max_07,WorldClim_2.1_FIO-ESM-2-0_ssp126_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jul,max T Jul,july,degrees Celsius,*degree*C*, +temperature_max_08,temperature_max_08,WorldClim_2.1_FIO-ESM-2-0_ssp126_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Aug,max T Aug,august,degrees Celsius,*degree*C*, +temperature_max_09,temperature_max_09,WorldClim_2.1_FIO-ESM-2-0_ssp126_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Sep,max T Sep,september,degrees Celsius,*degree*C*, +temperature_max_10,temperature_max_10,WorldClim_2.1_FIO-ESM-2-0_ssp126_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Oct,max T Oct,october,degrees Celsius,*degree*C*, +temperature_max_11,temperature_max_11,WorldClim_2.1_FIO-ESM-2-0_ssp126_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Nov,max T Nov,november,degrees Celsius,*degree*C*, +temperature_max_12,temperature_max_12,WorldClim_2.1_FIO-ESM-2-0_ssp126_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Dec,max T Dec,december,degrees Celsius,*degree*C*, +bio01,bio01,WorldClim_2.1_FIO-ESM-2-0_ssp126_5m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual mean temperature,ann. mean T,year,degrees Celsius,*degree*C*, +bio02,bio02,WorldClim_2.1_FIO-ESM-2-0_ssp126_5m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean diurnal range,diurn. range,year,degrees Celsius,*degree*C*, +bio03,bio03,WorldClim_2.1_FIO-ESM-2-0_ssp126_5m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,isothermality,isothermality,year,,, +bio04,bio04,WorldClim_2.1_FIO-ESM-2-0_ssp126_5m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature seasonality,T season.,year,degrees Celsius,*degree*C*, +bio05,bio05,WorldClim_2.1_FIO-ESM-2-0_ssp126_5m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature of warmest month,max. T of warmest mo.,year,degrees Celsius,*degree*C*, +bio06,bio06,WorldClim_2.1_FIO-ESM-2-0_ssp126_5m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature of coldest month,min. T of coldest mo.,year,degrees Celsius,*degree*C*, +bio07,bio07,WorldClim_2.1_FIO-ESM-2-0_ssp126_5m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature annual range (bio05-bio06),T ann. Range,year,degrees Celsius,*degree*C*, +bio08,bio08,WorldClim_2.1_FIO-ESM-2-0_ssp126_5m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of wettest quarter,mean T of wettest qtr,year,degrees Celsius,*degree*C*, +bio09,bio09,WorldClim_2.1_FIO-ESM-2-0_ssp126_5m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of driest quarter,mean T of driest qtr,year,degrees Celsius,*degree*C*, +bio10,bio10,WorldClim_2.1_FIO-ESM-2-0_ssp126_5m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of warmest quarter,mean T of warmest qtr,year,degrees Celsius,*degree*C*, +bio11,bio11,WorldClim_2.1_FIO-ESM-2-0_ssp126_5m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of coldest quarter,mean T of coldest qtr,year,degrees Celsius,*degree*C*, +bio12,bio12,WorldClim_2.1_FIO-ESM-2-0_ssp126_5m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual precipitation,ann. P,year,mm per year,*mm~yr^-1*, +bio13,bio13,WorldClim_2.1_FIO-ESM-2-0_ssp126_5m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest month,P of wettest mo.,year,mm per month,*mm~mo^-1*, +bio14,bio14,WorldClim_2.1_FIO-ESM-2-0_ssp126_5m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest month,P of driest mo.,year,mm per month,*mm~mo^-1*, +bio15,bio15,WorldClim_2.1_FIO-ESM-2-0_ssp126_5m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation seasonality (coeff var),P season.,year,,, +bio16,bio16,WorldClim_2.1_FIO-ESM-2-0_ssp126_5m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest quarter,P of wettest qtr,year,mm per quarter,*mm~qtr^-1*, +bio17,bio17,WorldClim_2.1_FIO-ESM-2-0_ssp126_5m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest quarter,P of driest qtr,year,mm per quarter,*mm~qtr^-1*, +bio18,bio18,WorldClim_2.1_FIO-ESM-2-0_ssp126_5m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of warmest quarter,P of warmest qtr,year,mm per quarter,*mm~qtr^-1*, +bio19,bio19,WorldClim_2.1_FIO-ESM-2-0_ssp126_5m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of coldest quarter,P of coldest qtr,year,mm per quarter,*mm~qtr^-1*, +precipitation_01,precipitation_01,WorldClim_2.1_FIO-ESM-2-0_ssp126_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jan,P Jan,january,mm per month,*mm~mo^-1*, +precipitation_02,precipitation_02,WorldClim_2.1_FIO-ESM-2-0_ssp126_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Feb,P Feb,february,mm per month,*mm~mo^-1*, +precipitation_03,precipitation_03,WorldClim_2.1_FIO-ESM-2-0_ssp126_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Mar,P Mar,march,mm per month,*mm~mo^-1*, +precipitation_04,precipitation_04,WorldClim_2.1_FIO-ESM-2-0_ssp126_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Apr,P Apr,april,mm per month,*mm~mo^-1*, +precipitation_05,precipitation_05,WorldClim_2.1_FIO-ESM-2-0_ssp126_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation May,P May,may,mm per month,*mm~mo^-1*, +precipitation_06,precipitation_06,WorldClim_2.1_FIO-ESM-2-0_ssp126_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jun,P Jun,june,mm per month,*mm~mo^-1*, +precipitation_07,precipitation_07,WorldClim_2.1_FIO-ESM-2-0_ssp126_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jul,P Jul,july,mm per month,*mm~mo^-1*, +precipitation_08,precipitation_08,WorldClim_2.1_FIO-ESM-2-0_ssp126_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Aug,P Aug,august,mm per month,*mm~mo^-1*, +precipitation_09,precipitation_09,WorldClim_2.1_FIO-ESM-2-0_ssp126_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Sep,P Sep,september,mm per month,*mm~mo^-1*, +precipitation_10,precipitation_10,WorldClim_2.1_FIO-ESM-2-0_ssp126_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Oct,P Oct,october,mm per month,*mm~mo^-1*, +precipitation_11,precipitation_11,WorldClim_2.1_FIO-ESM-2-0_ssp126_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Nov,P Nov,november,mm per month,*mm~mo^-1*, +precipitation_12,precipitation_12,WorldClim_2.1_FIO-ESM-2-0_ssp126_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Dec,P Dec,december,mm per month,*mm~mo^-1*, +temperature_min_01,temperature_min_01,WorldClim_2.1_FIO-ESM-2-0_ssp126_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jan,min T Jan,january,degrees Celsius,*degree*C*, +temperature_min_02,temperature_min_02,WorldClim_2.1_FIO-ESM-2-0_ssp126_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Feb,min T Feb,february,degrees Celsius,*degree*C*, +temperature_min_03,temperature_min_03,WorldClim_2.1_FIO-ESM-2-0_ssp126_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Mar,min T Mar,march,degrees Celsius,*degree*C*, +temperature_min_04,temperature_min_04,WorldClim_2.1_FIO-ESM-2-0_ssp126_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Apr,min T Apr,april,degrees Celsius,*degree*C*, +temperature_min_05,temperature_min_05,WorldClim_2.1_FIO-ESM-2-0_ssp126_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature May,min T May,may,degrees Celsius,*degree*C*, +temperature_min_06,temperature_min_06,WorldClim_2.1_FIO-ESM-2-0_ssp126_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jun,min T Jun,june,degrees Celsius,*degree*C*, +temperature_min_07,temperature_min_07,WorldClim_2.1_FIO-ESM-2-0_ssp126_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jul,min T Jul,july,degrees Celsius,*degree*C*, +temperature_min_08,temperature_min_08,WorldClim_2.1_FIO-ESM-2-0_ssp126_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Aug,min T Aug,august,degrees Celsius,*degree*C*, +temperature_min_09,temperature_min_09,WorldClim_2.1_FIO-ESM-2-0_ssp126_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Sep,min T Sep,september,degrees Celsius,*degree*C*, +temperature_min_10,temperature_min_10,WorldClim_2.1_FIO-ESM-2-0_ssp126_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Oct,min T Oct,october,degrees Celsius,*degree*C*, +temperature_min_11,temperature_min_11,WorldClim_2.1_FIO-ESM-2-0_ssp126_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Nov,min T Nov,november,degrees Celsius,*degree*C*, +temperature_min_12,temperature_min_12,WorldClim_2.1_FIO-ESM-2-0_ssp126_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Dec,min T Dec,december,degrees Celsius,*degree*C*, +temperature_max_01,temperature_max_01,WorldClim_2.1_FIO-ESM-2-0_ssp126_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jan,max T Jan,january,degrees Celsius,*degree*C*, +temperature_max_02,temperature_max_02,WorldClim_2.1_FIO-ESM-2-0_ssp126_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Feb,max T Feb,february,degrees Celsius,*degree*C*, +temperature_max_03,temperature_max_03,WorldClim_2.1_FIO-ESM-2-0_ssp126_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Mar,max T Mar,march,degrees Celsius,*degree*C*, +temperature_max_04,temperature_max_04,WorldClim_2.1_FIO-ESM-2-0_ssp126_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Apr,max T Apr,april,degrees Celsius,*degree*C*, +temperature_max_05,temperature_max_05,WorldClim_2.1_FIO-ESM-2-0_ssp126_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature May,max T May,may,degrees Celsius,*degree*C*, +temperature_max_06,temperature_max_06,WorldClim_2.1_FIO-ESM-2-0_ssp126_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jun,max T Jun,june,degrees Celsius,*degree*C*, +temperature_max_07,temperature_max_07,WorldClim_2.1_FIO-ESM-2-0_ssp126_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jul,max T Jul,july,degrees Celsius,*degree*C*, +temperature_max_08,temperature_max_08,WorldClim_2.1_FIO-ESM-2-0_ssp126_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Aug,max T Aug,august,degrees Celsius,*degree*C*, +temperature_max_09,temperature_max_09,WorldClim_2.1_FIO-ESM-2-0_ssp126_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Sep,max T Sep,september,degrees Celsius,*degree*C*, +temperature_max_10,temperature_max_10,WorldClim_2.1_FIO-ESM-2-0_ssp126_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Oct,max T Oct,october,degrees Celsius,*degree*C*, +temperature_max_11,temperature_max_11,WorldClim_2.1_FIO-ESM-2-0_ssp126_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Nov,max T Nov,november,degrees Celsius,*degree*C*, +temperature_max_12,temperature_max_12,WorldClim_2.1_FIO-ESM-2-0_ssp126_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Dec,max T Dec,december,degrees Celsius,*degree*C*, +bio01,bio01,WorldClim_2.1_FIO-ESM-2-0_ssp245_10m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual mean temperature,ann. mean T,year,degrees Celsius,*degree*C*, +bio02,bio02,WorldClim_2.1_FIO-ESM-2-0_ssp245_10m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean diurnal range,diurn. range,year,degrees Celsius,*degree*C*, +bio03,bio03,WorldClim_2.1_FIO-ESM-2-0_ssp245_10m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,isothermality,isothermality,year,,, +bio04,bio04,WorldClim_2.1_FIO-ESM-2-0_ssp245_10m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature seasonality,T season.,year,degrees Celsius,*degree*C*, +bio05,bio05,WorldClim_2.1_FIO-ESM-2-0_ssp245_10m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature of warmest month,max. T of warmest mo.,year,degrees Celsius,*degree*C*, +bio06,bio06,WorldClim_2.1_FIO-ESM-2-0_ssp245_10m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature of coldest month,min. T of coldest mo.,year,degrees Celsius,*degree*C*, +bio07,bio07,WorldClim_2.1_FIO-ESM-2-0_ssp245_10m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature annual range (bio05-bio06),T ann. Range,year,degrees Celsius,*degree*C*, +bio08,bio08,WorldClim_2.1_FIO-ESM-2-0_ssp245_10m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of wettest quarter,mean T of wettest qtr,year,degrees Celsius,*degree*C*, +bio09,bio09,WorldClim_2.1_FIO-ESM-2-0_ssp245_10m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of driest quarter,mean T of driest qtr,year,degrees Celsius,*degree*C*, +bio10,bio10,WorldClim_2.1_FIO-ESM-2-0_ssp245_10m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of warmest quarter,mean T of warmest qtr,year,degrees Celsius,*degree*C*, +bio11,bio11,WorldClim_2.1_FIO-ESM-2-0_ssp245_10m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of coldest quarter,mean T of coldest qtr,year,degrees Celsius,*degree*C*, +bio12,bio12,WorldClim_2.1_FIO-ESM-2-0_ssp245_10m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual precipitation,ann. P,year,mm per year,*mm~yr^-1*, +bio13,bio13,WorldClim_2.1_FIO-ESM-2-0_ssp245_10m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest month,P of wettest mo.,year,mm per month,*mm~mo^-1*, +bio14,bio14,WorldClim_2.1_FIO-ESM-2-0_ssp245_10m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest month,P of driest mo.,year,mm per month,*mm~mo^-1*, +bio15,bio15,WorldClim_2.1_FIO-ESM-2-0_ssp245_10m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation seasonality (coeff var),P season.,year,,, +bio16,bio16,WorldClim_2.1_FIO-ESM-2-0_ssp245_10m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest quarter,P of wettest qtr,year,mm per quarter,*mm~qtr^-1*, +bio17,bio17,WorldClim_2.1_FIO-ESM-2-0_ssp245_10m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest quarter,P of driest qtr,year,mm per quarter,*mm~qtr^-1*, +bio18,bio18,WorldClim_2.1_FIO-ESM-2-0_ssp245_10m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of warmest quarter,P of warmest qtr,year,mm per quarter,*mm~qtr^-1*, +bio19,bio19,WorldClim_2.1_FIO-ESM-2-0_ssp245_10m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of coldest quarter,P of coldest qtr,year,mm per quarter,*mm~qtr^-1*, +precipitation_01,precipitation_01,WorldClim_2.1_FIO-ESM-2-0_ssp245_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jan,P Jan,january,mm per month,*mm~mo^-1*, +precipitation_02,precipitation_02,WorldClim_2.1_FIO-ESM-2-0_ssp245_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Feb,P Feb,february,mm per month,*mm~mo^-1*, +precipitation_03,precipitation_03,WorldClim_2.1_FIO-ESM-2-0_ssp245_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Mar,P Mar,march,mm per month,*mm~mo^-1*, +precipitation_04,precipitation_04,WorldClim_2.1_FIO-ESM-2-0_ssp245_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Apr,P Apr,april,mm per month,*mm~mo^-1*, +precipitation_05,precipitation_05,WorldClim_2.1_FIO-ESM-2-0_ssp245_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation May,P May,may,mm per month,*mm~mo^-1*, +precipitation_06,precipitation_06,WorldClim_2.1_FIO-ESM-2-0_ssp245_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jun,P Jun,june,mm per month,*mm~mo^-1*, +precipitation_07,precipitation_07,WorldClim_2.1_FIO-ESM-2-0_ssp245_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jul,P Jul,july,mm per month,*mm~mo^-1*, +precipitation_08,precipitation_08,WorldClim_2.1_FIO-ESM-2-0_ssp245_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Aug,P Aug,august,mm per month,*mm~mo^-1*, +precipitation_09,precipitation_09,WorldClim_2.1_FIO-ESM-2-0_ssp245_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Sep,P Sep,september,mm per month,*mm~mo^-1*, +precipitation_10,precipitation_10,WorldClim_2.1_FIO-ESM-2-0_ssp245_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Oct,P Oct,october,mm per month,*mm~mo^-1*, +precipitation_11,precipitation_11,WorldClim_2.1_FIO-ESM-2-0_ssp245_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Nov,P Nov,november,mm per month,*mm~mo^-1*, +precipitation_12,precipitation_12,WorldClim_2.1_FIO-ESM-2-0_ssp245_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Dec,P Dec,december,mm per month,*mm~mo^-1*, +temperature_min_01,temperature_min_01,WorldClim_2.1_FIO-ESM-2-0_ssp245_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jan,min T Jan,january,degrees Celsius,*degree*C*, +temperature_min_02,temperature_min_02,WorldClim_2.1_FIO-ESM-2-0_ssp245_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Feb,min T Feb,february,degrees Celsius,*degree*C*, +temperature_min_03,temperature_min_03,WorldClim_2.1_FIO-ESM-2-0_ssp245_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Mar,min T Mar,march,degrees Celsius,*degree*C*, +temperature_min_04,temperature_min_04,WorldClim_2.1_FIO-ESM-2-0_ssp245_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Apr,min T Apr,april,degrees Celsius,*degree*C*, +temperature_min_05,temperature_min_05,WorldClim_2.1_FIO-ESM-2-0_ssp245_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature May,min T May,may,degrees Celsius,*degree*C*, +temperature_min_06,temperature_min_06,WorldClim_2.1_FIO-ESM-2-0_ssp245_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jun,min T Jun,june,degrees Celsius,*degree*C*, +temperature_min_07,temperature_min_07,WorldClim_2.1_FIO-ESM-2-0_ssp245_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jul,min T Jul,july,degrees Celsius,*degree*C*, +temperature_min_08,temperature_min_08,WorldClim_2.1_FIO-ESM-2-0_ssp245_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Aug,min T Aug,august,degrees Celsius,*degree*C*, +temperature_min_09,temperature_min_09,WorldClim_2.1_FIO-ESM-2-0_ssp245_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Sep,min T Sep,september,degrees Celsius,*degree*C*, +temperature_min_10,temperature_min_10,WorldClim_2.1_FIO-ESM-2-0_ssp245_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Oct,min T Oct,october,degrees Celsius,*degree*C*, +temperature_min_11,temperature_min_11,WorldClim_2.1_FIO-ESM-2-0_ssp245_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Nov,min T Nov,november,degrees Celsius,*degree*C*, +temperature_min_12,temperature_min_12,WorldClim_2.1_FIO-ESM-2-0_ssp245_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Dec,min T Dec,december,degrees Celsius,*degree*C*, +temperature_max_01,temperature_max_01,WorldClim_2.1_FIO-ESM-2-0_ssp245_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jan,max T Jan,january,degrees Celsius,*degree*C*, +temperature_max_02,temperature_max_02,WorldClim_2.1_FIO-ESM-2-0_ssp245_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Feb,max T Feb,february,degrees Celsius,*degree*C*, +temperature_max_03,temperature_max_03,WorldClim_2.1_FIO-ESM-2-0_ssp245_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Mar,max T Mar,march,degrees Celsius,*degree*C*, +temperature_max_04,temperature_max_04,WorldClim_2.1_FIO-ESM-2-0_ssp245_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Apr,max T Apr,april,degrees Celsius,*degree*C*, +temperature_max_05,temperature_max_05,WorldClim_2.1_FIO-ESM-2-0_ssp245_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature May,max T May,may,degrees Celsius,*degree*C*, +temperature_max_06,temperature_max_06,WorldClim_2.1_FIO-ESM-2-0_ssp245_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jun,max T Jun,june,degrees Celsius,*degree*C*, +temperature_max_07,temperature_max_07,WorldClim_2.1_FIO-ESM-2-0_ssp245_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jul,max T Jul,july,degrees Celsius,*degree*C*, +temperature_max_08,temperature_max_08,WorldClim_2.1_FIO-ESM-2-0_ssp245_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Aug,max T Aug,august,degrees Celsius,*degree*C*, +temperature_max_09,temperature_max_09,WorldClim_2.1_FIO-ESM-2-0_ssp245_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Sep,max T Sep,september,degrees Celsius,*degree*C*, +temperature_max_10,temperature_max_10,WorldClim_2.1_FIO-ESM-2-0_ssp245_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Oct,max T Oct,october,degrees Celsius,*degree*C*, +temperature_max_11,temperature_max_11,WorldClim_2.1_FIO-ESM-2-0_ssp245_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Nov,max T Nov,november,degrees Celsius,*degree*C*, +temperature_max_12,temperature_max_12,WorldClim_2.1_FIO-ESM-2-0_ssp245_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Dec,max T Dec,december,degrees Celsius,*degree*C*, +bio01,bio01,WorldClim_2.1_FIO-ESM-2-0_ssp245_5m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual mean temperature,ann. mean T,year,degrees Celsius,*degree*C*, +bio02,bio02,WorldClim_2.1_FIO-ESM-2-0_ssp245_5m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean diurnal range,diurn. range,year,degrees Celsius,*degree*C*, +bio03,bio03,WorldClim_2.1_FIO-ESM-2-0_ssp245_5m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,isothermality,isothermality,year,,, +bio04,bio04,WorldClim_2.1_FIO-ESM-2-0_ssp245_5m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature seasonality,T season.,year,degrees Celsius,*degree*C*, +bio05,bio05,WorldClim_2.1_FIO-ESM-2-0_ssp245_5m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature of warmest month,max. T of warmest mo.,year,degrees Celsius,*degree*C*, +bio06,bio06,WorldClim_2.1_FIO-ESM-2-0_ssp245_5m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature of coldest month,min. T of coldest mo.,year,degrees Celsius,*degree*C*, +bio07,bio07,WorldClim_2.1_FIO-ESM-2-0_ssp245_5m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature annual range (bio05-bio06),T ann. Range,year,degrees Celsius,*degree*C*, +bio08,bio08,WorldClim_2.1_FIO-ESM-2-0_ssp245_5m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of wettest quarter,mean T of wettest qtr,year,degrees Celsius,*degree*C*, +bio09,bio09,WorldClim_2.1_FIO-ESM-2-0_ssp245_5m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of driest quarter,mean T of driest qtr,year,degrees Celsius,*degree*C*, +bio10,bio10,WorldClim_2.1_FIO-ESM-2-0_ssp245_5m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of warmest quarter,mean T of warmest qtr,year,degrees Celsius,*degree*C*, +bio11,bio11,WorldClim_2.1_FIO-ESM-2-0_ssp245_5m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of coldest quarter,mean T of coldest qtr,year,degrees Celsius,*degree*C*, +bio12,bio12,WorldClim_2.1_FIO-ESM-2-0_ssp245_5m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual precipitation,ann. P,year,mm per year,*mm~yr^-1*, +bio13,bio13,WorldClim_2.1_FIO-ESM-2-0_ssp245_5m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest month,P of wettest mo.,year,mm per month,*mm~mo^-1*, +bio14,bio14,WorldClim_2.1_FIO-ESM-2-0_ssp245_5m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest month,P of driest mo.,year,mm per month,*mm~mo^-1*, +bio15,bio15,WorldClim_2.1_FIO-ESM-2-0_ssp245_5m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation seasonality (coeff var),P season.,year,,, +bio16,bio16,WorldClim_2.1_FIO-ESM-2-0_ssp245_5m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest quarter,P of wettest qtr,year,mm per quarter,*mm~qtr^-1*, +bio17,bio17,WorldClim_2.1_FIO-ESM-2-0_ssp245_5m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest quarter,P of driest qtr,year,mm per quarter,*mm~qtr^-1*, +bio18,bio18,WorldClim_2.1_FIO-ESM-2-0_ssp245_5m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of warmest quarter,P of warmest qtr,year,mm per quarter,*mm~qtr^-1*, +bio19,bio19,WorldClim_2.1_FIO-ESM-2-0_ssp245_5m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of coldest quarter,P of coldest qtr,year,mm per quarter,*mm~qtr^-1*, +precipitation_01,precipitation_01,WorldClim_2.1_FIO-ESM-2-0_ssp245_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jan,P Jan,january,mm per month,*mm~mo^-1*, +precipitation_02,precipitation_02,WorldClim_2.1_FIO-ESM-2-0_ssp245_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Feb,P Feb,february,mm per month,*mm~mo^-1*, +precipitation_03,precipitation_03,WorldClim_2.1_FIO-ESM-2-0_ssp245_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Mar,P Mar,march,mm per month,*mm~mo^-1*, +precipitation_04,precipitation_04,WorldClim_2.1_FIO-ESM-2-0_ssp245_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Apr,P Apr,april,mm per month,*mm~mo^-1*, +precipitation_05,precipitation_05,WorldClim_2.1_FIO-ESM-2-0_ssp245_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation May,P May,may,mm per month,*mm~mo^-1*, +precipitation_06,precipitation_06,WorldClim_2.1_FIO-ESM-2-0_ssp245_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jun,P Jun,june,mm per month,*mm~mo^-1*, +precipitation_07,precipitation_07,WorldClim_2.1_FIO-ESM-2-0_ssp245_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jul,P Jul,july,mm per month,*mm~mo^-1*, +precipitation_08,precipitation_08,WorldClim_2.1_FIO-ESM-2-0_ssp245_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Aug,P Aug,august,mm per month,*mm~mo^-1*, +precipitation_09,precipitation_09,WorldClim_2.1_FIO-ESM-2-0_ssp245_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Sep,P Sep,september,mm per month,*mm~mo^-1*, +precipitation_10,precipitation_10,WorldClim_2.1_FIO-ESM-2-0_ssp245_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Oct,P Oct,october,mm per month,*mm~mo^-1*, +precipitation_11,precipitation_11,WorldClim_2.1_FIO-ESM-2-0_ssp245_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Nov,P Nov,november,mm per month,*mm~mo^-1*, +precipitation_12,precipitation_12,WorldClim_2.1_FIO-ESM-2-0_ssp245_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Dec,P Dec,december,mm per month,*mm~mo^-1*, +temperature_min_01,temperature_min_01,WorldClim_2.1_FIO-ESM-2-0_ssp245_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jan,min T Jan,january,degrees Celsius,*degree*C*, +temperature_min_02,temperature_min_02,WorldClim_2.1_FIO-ESM-2-0_ssp245_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Feb,min T Feb,february,degrees Celsius,*degree*C*, +temperature_min_03,temperature_min_03,WorldClim_2.1_FIO-ESM-2-0_ssp245_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Mar,min T Mar,march,degrees Celsius,*degree*C*, +temperature_min_04,temperature_min_04,WorldClim_2.1_FIO-ESM-2-0_ssp245_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Apr,min T Apr,april,degrees Celsius,*degree*C*, +temperature_min_05,temperature_min_05,WorldClim_2.1_FIO-ESM-2-0_ssp245_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature May,min T May,may,degrees Celsius,*degree*C*, +temperature_min_06,temperature_min_06,WorldClim_2.1_FIO-ESM-2-0_ssp245_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jun,min T Jun,june,degrees Celsius,*degree*C*, +temperature_min_07,temperature_min_07,WorldClim_2.1_FIO-ESM-2-0_ssp245_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jul,min T Jul,july,degrees Celsius,*degree*C*, +temperature_min_08,temperature_min_08,WorldClim_2.1_FIO-ESM-2-0_ssp245_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Aug,min T Aug,august,degrees Celsius,*degree*C*, +temperature_min_09,temperature_min_09,WorldClim_2.1_FIO-ESM-2-0_ssp245_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Sep,min T Sep,september,degrees Celsius,*degree*C*, +temperature_min_10,temperature_min_10,WorldClim_2.1_FIO-ESM-2-0_ssp245_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Oct,min T Oct,october,degrees Celsius,*degree*C*, +temperature_min_11,temperature_min_11,WorldClim_2.1_FIO-ESM-2-0_ssp245_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Nov,min T Nov,november,degrees Celsius,*degree*C*, +temperature_min_12,temperature_min_12,WorldClim_2.1_FIO-ESM-2-0_ssp245_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Dec,min T Dec,december,degrees Celsius,*degree*C*, +temperature_max_01,temperature_max_01,WorldClim_2.1_FIO-ESM-2-0_ssp245_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jan,max T Jan,january,degrees Celsius,*degree*C*, +temperature_max_02,temperature_max_02,WorldClim_2.1_FIO-ESM-2-0_ssp245_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Feb,max T Feb,february,degrees Celsius,*degree*C*, +temperature_max_03,temperature_max_03,WorldClim_2.1_FIO-ESM-2-0_ssp245_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Mar,max T Mar,march,degrees Celsius,*degree*C*, +temperature_max_04,temperature_max_04,WorldClim_2.1_FIO-ESM-2-0_ssp245_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Apr,max T Apr,april,degrees Celsius,*degree*C*, +temperature_max_05,temperature_max_05,WorldClim_2.1_FIO-ESM-2-0_ssp245_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature May,max T May,may,degrees Celsius,*degree*C*, +temperature_max_06,temperature_max_06,WorldClim_2.1_FIO-ESM-2-0_ssp245_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jun,max T Jun,june,degrees Celsius,*degree*C*, +temperature_max_07,temperature_max_07,WorldClim_2.1_FIO-ESM-2-0_ssp245_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jul,max T Jul,july,degrees Celsius,*degree*C*, +temperature_max_08,temperature_max_08,WorldClim_2.1_FIO-ESM-2-0_ssp245_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Aug,max T Aug,august,degrees Celsius,*degree*C*, +temperature_max_09,temperature_max_09,WorldClim_2.1_FIO-ESM-2-0_ssp245_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Sep,max T Sep,september,degrees Celsius,*degree*C*, +temperature_max_10,temperature_max_10,WorldClim_2.1_FIO-ESM-2-0_ssp245_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Oct,max T Oct,october,degrees Celsius,*degree*C*, +temperature_max_11,temperature_max_11,WorldClim_2.1_FIO-ESM-2-0_ssp245_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Nov,max T Nov,november,degrees Celsius,*degree*C*, +temperature_max_12,temperature_max_12,WorldClim_2.1_FIO-ESM-2-0_ssp245_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Dec,max T Dec,december,degrees Celsius,*degree*C*, +bio01,bio01,WorldClim_2.1_FIO-ESM-2-0_ssp370_10m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual mean temperature,ann. mean T,year,degrees Celsius,*degree*C*, +bio02,bio02,WorldClim_2.1_FIO-ESM-2-0_ssp370_10m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean diurnal range,diurn. range,year,degrees Celsius,*degree*C*, +bio03,bio03,WorldClim_2.1_FIO-ESM-2-0_ssp370_10m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,isothermality,isothermality,year,,, +bio04,bio04,WorldClim_2.1_FIO-ESM-2-0_ssp370_10m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature seasonality,T season.,year,degrees Celsius,*degree*C*, +bio05,bio05,WorldClim_2.1_FIO-ESM-2-0_ssp370_10m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature of warmest month,max. T of warmest mo.,year,degrees Celsius,*degree*C*, +bio06,bio06,WorldClim_2.1_FIO-ESM-2-0_ssp370_10m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature of coldest month,min. T of coldest mo.,year,degrees Celsius,*degree*C*, +bio07,bio07,WorldClim_2.1_FIO-ESM-2-0_ssp370_10m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature annual range (bio05-bio06),T ann. Range,year,degrees Celsius,*degree*C*, +bio08,bio08,WorldClim_2.1_FIO-ESM-2-0_ssp370_10m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of wettest quarter,mean T of wettest qtr,year,degrees Celsius,*degree*C*, +bio09,bio09,WorldClim_2.1_FIO-ESM-2-0_ssp370_10m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of driest quarter,mean T of driest qtr,year,degrees Celsius,*degree*C*, +bio10,bio10,WorldClim_2.1_FIO-ESM-2-0_ssp370_10m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of warmest quarter,mean T of warmest qtr,year,degrees Celsius,*degree*C*, +bio11,bio11,WorldClim_2.1_FIO-ESM-2-0_ssp370_10m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of coldest quarter,mean T of coldest qtr,year,degrees Celsius,*degree*C*, +bio12,bio12,WorldClim_2.1_FIO-ESM-2-0_ssp370_10m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual precipitation,ann. P,year,mm per year,*mm~yr^-1*, +bio13,bio13,WorldClim_2.1_FIO-ESM-2-0_ssp370_10m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest month,P of wettest mo.,year,mm per month,*mm~mo^-1*, +bio14,bio14,WorldClim_2.1_FIO-ESM-2-0_ssp370_10m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest month,P of driest mo.,year,mm per month,*mm~mo^-1*, +bio15,bio15,WorldClim_2.1_FIO-ESM-2-0_ssp370_10m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation seasonality (coeff var),P season.,year,,, +bio16,bio16,WorldClim_2.1_FIO-ESM-2-0_ssp370_10m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest quarter,P of wettest qtr,year,mm per quarter,*mm~qtr^-1*, +bio17,bio17,WorldClim_2.1_FIO-ESM-2-0_ssp370_10m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest quarter,P of driest qtr,year,mm per quarter,*mm~qtr^-1*, +bio18,bio18,WorldClim_2.1_FIO-ESM-2-0_ssp370_10m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of warmest quarter,P of warmest qtr,year,mm per quarter,*mm~qtr^-1*, +bio19,bio19,WorldClim_2.1_FIO-ESM-2-0_ssp370_10m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of coldest quarter,P of coldest qtr,year,mm per quarter,*mm~qtr^-1*, +precipitation_01,precipitation_01,WorldClim_2.1_FIO-ESM-2-0_ssp370_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jan,P Jan,january,mm per month,*mm~mo^-1*, +precipitation_02,precipitation_02,WorldClim_2.1_FIO-ESM-2-0_ssp370_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Feb,P Feb,february,mm per month,*mm~mo^-1*, +precipitation_03,precipitation_03,WorldClim_2.1_FIO-ESM-2-0_ssp370_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Mar,P Mar,march,mm per month,*mm~mo^-1*, +precipitation_04,precipitation_04,WorldClim_2.1_FIO-ESM-2-0_ssp370_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Apr,P Apr,april,mm per month,*mm~mo^-1*, +precipitation_05,precipitation_05,WorldClim_2.1_FIO-ESM-2-0_ssp370_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation May,P May,may,mm per month,*mm~mo^-1*, +precipitation_06,precipitation_06,WorldClim_2.1_FIO-ESM-2-0_ssp370_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jun,P Jun,june,mm per month,*mm~mo^-1*, +precipitation_07,precipitation_07,WorldClim_2.1_FIO-ESM-2-0_ssp370_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jul,P Jul,july,mm per month,*mm~mo^-1*, +precipitation_08,precipitation_08,WorldClim_2.1_FIO-ESM-2-0_ssp370_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Aug,P Aug,august,mm per month,*mm~mo^-1*, +precipitation_09,precipitation_09,WorldClim_2.1_FIO-ESM-2-0_ssp370_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Sep,P Sep,september,mm per month,*mm~mo^-1*, +precipitation_10,precipitation_10,WorldClim_2.1_FIO-ESM-2-0_ssp370_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Oct,P Oct,october,mm per month,*mm~mo^-1*, +precipitation_11,precipitation_11,WorldClim_2.1_FIO-ESM-2-0_ssp370_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Nov,P Nov,november,mm per month,*mm~mo^-1*, +precipitation_12,precipitation_12,WorldClim_2.1_FIO-ESM-2-0_ssp370_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Dec,P Dec,december,mm per month,*mm~mo^-1*, +temperature_min_01,temperature_min_01,WorldClim_2.1_FIO-ESM-2-0_ssp370_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jan,min T Jan,january,degrees Celsius,*degree*C*, +temperature_min_02,temperature_min_02,WorldClim_2.1_FIO-ESM-2-0_ssp370_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Feb,min T Feb,february,degrees Celsius,*degree*C*, +temperature_min_03,temperature_min_03,WorldClim_2.1_FIO-ESM-2-0_ssp370_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Mar,min T Mar,march,degrees Celsius,*degree*C*, +temperature_min_04,temperature_min_04,WorldClim_2.1_FIO-ESM-2-0_ssp370_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Apr,min T Apr,april,degrees Celsius,*degree*C*, +temperature_min_05,temperature_min_05,WorldClim_2.1_FIO-ESM-2-0_ssp370_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature May,min T May,may,degrees Celsius,*degree*C*, +temperature_min_06,temperature_min_06,WorldClim_2.1_FIO-ESM-2-0_ssp370_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jun,min T Jun,june,degrees Celsius,*degree*C*, +temperature_min_07,temperature_min_07,WorldClim_2.1_FIO-ESM-2-0_ssp370_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jul,min T Jul,july,degrees Celsius,*degree*C*, +temperature_min_08,temperature_min_08,WorldClim_2.1_FIO-ESM-2-0_ssp370_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Aug,min T Aug,august,degrees Celsius,*degree*C*, +temperature_min_09,temperature_min_09,WorldClim_2.1_FIO-ESM-2-0_ssp370_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Sep,min T Sep,september,degrees Celsius,*degree*C*, +temperature_min_10,temperature_min_10,WorldClim_2.1_FIO-ESM-2-0_ssp370_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Oct,min T Oct,october,degrees Celsius,*degree*C*, +temperature_min_11,temperature_min_11,WorldClim_2.1_FIO-ESM-2-0_ssp370_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Nov,min T Nov,november,degrees Celsius,*degree*C*, +temperature_min_12,temperature_min_12,WorldClim_2.1_FIO-ESM-2-0_ssp370_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Dec,min T Dec,december,degrees Celsius,*degree*C*, +temperature_max_01,temperature_max_01,WorldClim_2.1_FIO-ESM-2-0_ssp370_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jan,max T Jan,january,degrees Celsius,*degree*C*, +temperature_max_02,temperature_max_02,WorldClim_2.1_FIO-ESM-2-0_ssp370_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Feb,max T Feb,february,degrees Celsius,*degree*C*, +temperature_max_03,temperature_max_03,WorldClim_2.1_FIO-ESM-2-0_ssp370_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Mar,max T Mar,march,degrees Celsius,*degree*C*, +temperature_max_04,temperature_max_04,WorldClim_2.1_FIO-ESM-2-0_ssp370_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Apr,max T Apr,april,degrees Celsius,*degree*C*, +temperature_max_05,temperature_max_05,WorldClim_2.1_FIO-ESM-2-0_ssp370_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature May,max T May,may,degrees Celsius,*degree*C*, +temperature_max_06,temperature_max_06,WorldClim_2.1_FIO-ESM-2-0_ssp370_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jun,max T Jun,june,degrees Celsius,*degree*C*, +temperature_max_07,temperature_max_07,WorldClim_2.1_FIO-ESM-2-0_ssp370_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jul,max T Jul,july,degrees Celsius,*degree*C*, +temperature_max_08,temperature_max_08,WorldClim_2.1_FIO-ESM-2-0_ssp370_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Aug,max T Aug,august,degrees Celsius,*degree*C*, +temperature_max_09,temperature_max_09,WorldClim_2.1_FIO-ESM-2-0_ssp370_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Sep,max T Sep,september,degrees Celsius,*degree*C*, +temperature_max_10,temperature_max_10,WorldClim_2.1_FIO-ESM-2-0_ssp370_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Oct,max T Oct,october,degrees Celsius,*degree*C*, +temperature_max_11,temperature_max_11,WorldClim_2.1_FIO-ESM-2-0_ssp370_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Nov,max T Nov,november,degrees Celsius,*degree*C*, +temperature_max_12,temperature_max_12,WorldClim_2.1_FIO-ESM-2-0_ssp370_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Dec,max T Dec,december,degrees Celsius,*degree*C*, +bio01,bio01,WorldClim_2.1_FIO-ESM-2-0_ssp370_5m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual mean temperature,ann. mean T,year,degrees Celsius,*degree*C*, +bio02,bio02,WorldClim_2.1_FIO-ESM-2-0_ssp370_5m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean diurnal range,diurn. range,year,degrees Celsius,*degree*C*, +bio03,bio03,WorldClim_2.1_FIO-ESM-2-0_ssp370_5m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,isothermality,isothermality,year,,, +bio04,bio04,WorldClim_2.1_FIO-ESM-2-0_ssp370_5m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature seasonality,T season.,year,degrees Celsius,*degree*C*, +bio05,bio05,WorldClim_2.1_FIO-ESM-2-0_ssp370_5m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature of warmest month,max. T of warmest mo.,year,degrees Celsius,*degree*C*, +bio06,bio06,WorldClim_2.1_FIO-ESM-2-0_ssp370_5m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature of coldest month,min. T of coldest mo.,year,degrees Celsius,*degree*C*, +bio07,bio07,WorldClim_2.1_FIO-ESM-2-0_ssp370_5m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature annual range (bio05-bio06),T ann. Range,year,degrees Celsius,*degree*C*, +bio08,bio08,WorldClim_2.1_FIO-ESM-2-0_ssp370_5m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of wettest quarter,mean T of wettest qtr,year,degrees Celsius,*degree*C*, +bio09,bio09,WorldClim_2.1_FIO-ESM-2-0_ssp370_5m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of driest quarter,mean T of driest qtr,year,degrees Celsius,*degree*C*, +bio10,bio10,WorldClim_2.1_FIO-ESM-2-0_ssp370_5m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of warmest quarter,mean T of warmest qtr,year,degrees Celsius,*degree*C*, +bio11,bio11,WorldClim_2.1_FIO-ESM-2-0_ssp370_5m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of coldest quarter,mean T of coldest qtr,year,degrees Celsius,*degree*C*, +bio12,bio12,WorldClim_2.1_FIO-ESM-2-0_ssp370_5m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual precipitation,ann. P,year,mm per year,*mm~yr^-1*, +bio13,bio13,WorldClim_2.1_FIO-ESM-2-0_ssp370_5m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest month,P of wettest mo.,year,mm per month,*mm~mo^-1*, +bio14,bio14,WorldClim_2.1_FIO-ESM-2-0_ssp370_5m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest month,P of driest mo.,year,mm per month,*mm~mo^-1*, +bio15,bio15,WorldClim_2.1_FIO-ESM-2-0_ssp370_5m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation seasonality (coeff var),P season.,year,,, +bio16,bio16,WorldClim_2.1_FIO-ESM-2-0_ssp370_5m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest quarter,P of wettest qtr,year,mm per quarter,*mm~qtr^-1*, +bio17,bio17,WorldClim_2.1_FIO-ESM-2-0_ssp370_5m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest quarter,P of driest qtr,year,mm per quarter,*mm~qtr^-1*, +bio18,bio18,WorldClim_2.1_FIO-ESM-2-0_ssp370_5m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of warmest quarter,P of warmest qtr,year,mm per quarter,*mm~qtr^-1*, +bio19,bio19,WorldClim_2.1_FIO-ESM-2-0_ssp370_5m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of coldest quarter,P of coldest qtr,year,mm per quarter,*mm~qtr^-1*, +precipitation_01,precipitation_01,WorldClim_2.1_FIO-ESM-2-0_ssp370_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jan,P Jan,january,mm per month,*mm~mo^-1*, +precipitation_02,precipitation_02,WorldClim_2.1_FIO-ESM-2-0_ssp370_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Feb,P Feb,february,mm per month,*mm~mo^-1*, +precipitation_03,precipitation_03,WorldClim_2.1_FIO-ESM-2-0_ssp370_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Mar,P Mar,march,mm per month,*mm~mo^-1*, +precipitation_04,precipitation_04,WorldClim_2.1_FIO-ESM-2-0_ssp370_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Apr,P Apr,april,mm per month,*mm~mo^-1*, +precipitation_05,precipitation_05,WorldClim_2.1_FIO-ESM-2-0_ssp370_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation May,P May,may,mm per month,*mm~mo^-1*, +precipitation_06,precipitation_06,WorldClim_2.1_FIO-ESM-2-0_ssp370_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jun,P Jun,june,mm per month,*mm~mo^-1*, +precipitation_07,precipitation_07,WorldClim_2.1_FIO-ESM-2-0_ssp370_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jul,P Jul,july,mm per month,*mm~mo^-1*, +precipitation_08,precipitation_08,WorldClim_2.1_FIO-ESM-2-0_ssp370_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Aug,P Aug,august,mm per month,*mm~mo^-1*, +precipitation_09,precipitation_09,WorldClim_2.1_FIO-ESM-2-0_ssp370_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Sep,P Sep,september,mm per month,*mm~mo^-1*, +precipitation_10,precipitation_10,WorldClim_2.1_FIO-ESM-2-0_ssp370_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Oct,P Oct,october,mm per month,*mm~mo^-1*, +precipitation_11,precipitation_11,WorldClim_2.1_FIO-ESM-2-0_ssp370_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Nov,P Nov,november,mm per month,*mm~mo^-1*, +precipitation_12,precipitation_12,WorldClim_2.1_FIO-ESM-2-0_ssp370_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Dec,P Dec,december,mm per month,*mm~mo^-1*, +temperature_min_01,temperature_min_01,WorldClim_2.1_FIO-ESM-2-0_ssp370_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jan,min T Jan,january,degrees Celsius,*degree*C*, +temperature_min_02,temperature_min_02,WorldClim_2.1_FIO-ESM-2-0_ssp370_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Feb,min T Feb,february,degrees Celsius,*degree*C*, +temperature_min_03,temperature_min_03,WorldClim_2.1_FIO-ESM-2-0_ssp370_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Mar,min T Mar,march,degrees Celsius,*degree*C*, +temperature_min_04,temperature_min_04,WorldClim_2.1_FIO-ESM-2-0_ssp370_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Apr,min T Apr,april,degrees Celsius,*degree*C*, +temperature_min_05,temperature_min_05,WorldClim_2.1_FIO-ESM-2-0_ssp370_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature May,min T May,may,degrees Celsius,*degree*C*, +temperature_min_06,temperature_min_06,WorldClim_2.1_FIO-ESM-2-0_ssp370_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jun,min T Jun,june,degrees Celsius,*degree*C*, +temperature_min_07,temperature_min_07,WorldClim_2.1_FIO-ESM-2-0_ssp370_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jul,min T Jul,july,degrees Celsius,*degree*C*, +temperature_min_08,temperature_min_08,WorldClim_2.1_FIO-ESM-2-0_ssp370_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Aug,min T Aug,august,degrees Celsius,*degree*C*, +temperature_min_09,temperature_min_09,WorldClim_2.1_FIO-ESM-2-0_ssp370_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Sep,min T Sep,september,degrees Celsius,*degree*C*, +temperature_min_10,temperature_min_10,WorldClim_2.1_FIO-ESM-2-0_ssp370_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Oct,min T Oct,october,degrees Celsius,*degree*C*, +temperature_min_11,temperature_min_11,WorldClim_2.1_FIO-ESM-2-0_ssp370_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Nov,min T Nov,november,degrees Celsius,*degree*C*, +temperature_min_12,temperature_min_12,WorldClim_2.1_FIO-ESM-2-0_ssp370_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Dec,min T Dec,december,degrees Celsius,*degree*C*, +temperature_max_01,temperature_max_01,WorldClim_2.1_FIO-ESM-2-0_ssp370_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jan,max T Jan,january,degrees Celsius,*degree*C*, +temperature_max_02,temperature_max_02,WorldClim_2.1_FIO-ESM-2-0_ssp370_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Feb,max T Feb,february,degrees Celsius,*degree*C*, +temperature_max_03,temperature_max_03,WorldClim_2.1_FIO-ESM-2-0_ssp370_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Mar,max T Mar,march,degrees Celsius,*degree*C*, +temperature_max_04,temperature_max_04,WorldClim_2.1_FIO-ESM-2-0_ssp370_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Apr,max T Apr,april,degrees Celsius,*degree*C*, +temperature_max_05,temperature_max_05,WorldClim_2.1_FIO-ESM-2-0_ssp370_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature May,max T May,may,degrees Celsius,*degree*C*, +temperature_max_06,temperature_max_06,WorldClim_2.1_FIO-ESM-2-0_ssp370_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jun,max T Jun,june,degrees Celsius,*degree*C*, +temperature_max_07,temperature_max_07,WorldClim_2.1_FIO-ESM-2-0_ssp370_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jul,max T Jul,july,degrees Celsius,*degree*C*, +temperature_max_08,temperature_max_08,WorldClim_2.1_FIO-ESM-2-0_ssp370_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Aug,max T Aug,august,degrees Celsius,*degree*C*, +temperature_max_09,temperature_max_09,WorldClim_2.1_FIO-ESM-2-0_ssp370_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Sep,max T Sep,september,degrees Celsius,*degree*C*, +temperature_max_10,temperature_max_10,WorldClim_2.1_FIO-ESM-2-0_ssp370_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Oct,max T Oct,october,degrees Celsius,*degree*C*, +temperature_max_11,temperature_max_11,WorldClim_2.1_FIO-ESM-2-0_ssp370_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Nov,max T Nov,november,degrees Celsius,*degree*C*, +temperature_max_12,temperature_max_12,WorldClim_2.1_FIO-ESM-2-0_ssp370_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Dec,max T Dec,december,degrees Celsius,*degree*C*, +bio01,bio01,WorldClim_2.1_FIO-ESM-2-0_ssp585_10m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual mean temperature,ann. mean T,year,degrees Celsius,*degree*C*, +bio02,bio02,WorldClim_2.1_FIO-ESM-2-0_ssp585_10m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean diurnal range,diurn. range,year,degrees Celsius,*degree*C*, +bio03,bio03,WorldClim_2.1_FIO-ESM-2-0_ssp585_10m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,isothermality,isothermality,year,,, +bio04,bio04,WorldClim_2.1_FIO-ESM-2-0_ssp585_10m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature seasonality,T season.,year,degrees Celsius,*degree*C*, +bio05,bio05,WorldClim_2.1_FIO-ESM-2-0_ssp585_10m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature of warmest month,max. T of warmest mo.,year,degrees Celsius,*degree*C*, +bio06,bio06,WorldClim_2.1_FIO-ESM-2-0_ssp585_10m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature of coldest month,min. T of coldest mo.,year,degrees Celsius,*degree*C*, +bio07,bio07,WorldClim_2.1_FIO-ESM-2-0_ssp585_10m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature annual range (bio05-bio06),T ann. Range,year,degrees Celsius,*degree*C*, +bio08,bio08,WorldClim_2.1_FIO-ESM-2-0_ssp585_10m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of wettest quarter,mean T of wettest qtr,year,degrees Celsius,*degree*C*, +bio09,bio09,WorldClim_2.1_FIO-ESM-2-0_ssp585_10m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of driest quarter,mean T of driest qtr,year,degrees Celsius,*degree*C*, +bio10,bio10,WorldClim_2.1_FIO-ESM-2-0_ssp585_10m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of warmest quarter,mean T of warmest qtr,year,degrees Celsius,*degree*C*, +bio11,bio11,WorldClim_2.1_FIO-ESM-2-0_ssp585_10m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of coldest quarter,mean T of coldest qtr,year,degrees Celsius,*degree*C*, +bio12,bio12,WorldClim_2.1_FIO-ESM-2-0_ssp585_10m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual precipitation,ann. P,year,mm per year,*mm~yr^-1*, +bio13,bio13,WorldClim_2.1_FIO-ESM-2-0_ssp585_10m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest month,P of wettest mo.,year,mm per month,*mm~mo^-1*, +bio14,bio14,WorldClim_2.1_FIO-ESM-2-0_ssp585_10m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest month,P of driest mo.,year,mm per month,*mm~mo^-1*, +bio15,bio15,WorldClim_2.1_FIO-ESM-2-0_ssp585_10m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation seasonality (coeff var),P season.,year,,, +bio16,bio16,WorldClim_2.1_FIO-ESM-2-0_ssp585_10m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest quarter,P of wettest qtr,year,mm per quarter,*mm~qtr^-1*, +bio17,bio17,WorldClim_2.1_FIO-ESM-2-0_ssp585_10m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest quarter,P of driest qtr,year,mm per quarter,*mm~qtr^-1*, +bio18,bio18,WorldClim_2.1_FIO-ESM-2-0_ssp585_10m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of warmest quarter,P of warmest qtr,year,mm per quarter,*mm~qtr^-1*, +bio19,bio19,WorldClim_2.1_FIO-ESM-2-0_ssp585_10m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of coldest quarter,P of coldest qtr,year,mm per quarter,*mm~qtr^-1*, +precipitation_01,precipitation_01,WorldClim_2.1_FIO-ESM-2-0_ssp585_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jan,P Jan,january,mm per month,*mm~mo^-1*, +precipitation_02,precipitation_02,WorldClim_2.1_FIO-ESM-2-0_ssp585_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Feb,P Feb,february,mm per month,*mm~mo^-1*, +precipitation_03,precipitation_03,WorldClim_2.1_FIO-ESM-2-0_ssp585_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Mar,P Mar,march,mm per month,*mm~mo^-1*, +precipitation_04,precipitation_04,WorldClim_2.1_FIO-ESM-2-0_ssp585_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Apr,P Apr,april,mm per month,*mm~mo^-1*, +precipitation_05,precipitation_05,WorldClim_2.1_FIO-ESM-2-0_ssp585_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation May,P May,may,mm per month,*mm~mo^-1*, +precipitation_06,precipitation_06,WorldClim_2.1_FIO-ESM-2-0_ssp585_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jun,P Jun,june,mm per month,*mm~mo^-1*, +precipitation_07,precipitation_07,WorldClim_2.1_FIO-ESM-2-0_ssp585_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jul,P Jul,july,mm per month,*mm~mo^-1*, +precipitation_08,precipitation_08,WorldClim_2.1_FIO-ESM-2-0_ssp585_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Aug,P Aug,august,mm per month,*mm~mo^-1*, +precipitation_09,precipitation_09,WorldClim_2.1_FIO-ESM-2-0_ssp585_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Sep,P Sep,september,mm per month,*mm~mo^-1*, +precipitation_10,precipitation_10,WorldClim_2.1_FIO-ESM-2-0_ssp585_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Oct,P Oct,october,mm per month,*mm~mo^-1*, +precipitation_11,precipitation_11,WorldClim_2.1_FIO-ESM-2-0_ssp585_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Nov,P Nov,november,mm per month,*mm~mo^-1*, +precipitation_12,precipitation_12,WorldClim_2.1_FIO-ESM-2-0_ssp585_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Dec,P Dec,december,mm per month,*mm~mo^-1*, +temperature_min_01,temperature_min_01,WorldClim_2.1_FIO-ESM-2-0_ssp585_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jan,min T Jan,january,degrees Celsius,*degree*C*, +temperature_min_02,temperature_min_02,WorldClim_2.1_FIO-ESM-2-0_ssp585_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Feb,min T Feb,february,degrees Celsius,*degree*C*, +temperature_min_03,temperature_min_03,WorldClim_2.1_FIO-ESM-2-0_ssp585_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Mar,min T Mar,march,degrees Celsius,*degree*C*, +temperature_min_04,temperature_min_04,WorldClim_2.1_FIO-ESM-2-0_ssp585_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Apr,min T Apr,april,degrees Celsius,*degree*C*, +temperature_min_05,temperature_min_05,WorldClim_2.1_FIO-ESM-2-0_ssp585_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature May,min T May,may,degrees Celsius,*degree*C*, +temperature_min_06,temperature_min_06,WorldClim_2.1_FIO-ESM-2-0_ssp585_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jun,min T Jun,june,degrees Celsius,*degree*C*, +temperature_min_07,temperature_min_07,WorldClim_2.1_FIO-ESM-2-0_ssp585_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jul,min T Jul,july,degrees Celsius,*degree*C*, +temperature_min_08,temperature_min_08,WorldClim_2.1_FIO-ESM-2-0_ssp585_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Aug,min T Aug,august,degrees Celsius,*degree*C*, +temperature_min_09,temperature_min_09,WorldClim_2.1_FIO-ESM-2-0_ssp585_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Sep,min T Sep,september,degrees Celsius,*degree*C*, +temperature_min_10,temperature_min_10,WorldClim_2.1_FIO-ESM-2-0_ssp585_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Oct,min T Oct,october,degrees Celsius,*degree*C*, +temperature_min_11,temperature_min_11,WorldClim_2.1_FIO-ESM-2-0_ssp585_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Nov,min T Nov,november,degrees Celsius,*degree*C*, +temperature_min_12,temperature_min_12,WorldClim_2.1_FIO-ESM-2-0_ssp585_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Dec,min T Dec,december,degrees Celsius,*degree*C*, +temperature_max_01,temperature_max_01,WorldClim_2.1_FIO-ESM-2-0_ssp585_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jan,max T Jan,january,degrees Celsius,*degree*C*, +temperature_max_02,temperature_max_02,WorldClim_2.1_FIO-ESM-2-0_ssp585_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Feb,max T Feb,february,degrees Celsius,*degree*C*, +temperature_max_03,temperature_max_03,WorldClim_2.1_FIO-ESM-2-0_ssp585_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Mar,max T Mar,march,degrees Celsius,*degree*C*, +temperature_max_04,temperature_max_04,WorldClim_2.1_FIO-ESM-2-0_ssp585_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Apr,max T Apr,april,degrees Celsius,*degree*C*, +temperature_max_05,temperature_max_05,WorldClim_2.1_FIO-ESM-2-0_ssp585_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature May,max T May,may,degrees Celsius,*degree*C*, +temperature_max_06,temperature_max_06,WorldClim_2.1_FIO-ESM-2-0_ssp585_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jun,max T Jun,june,degrees Celsius,*degree*C*, +temperature_max_07,temperature_max_07,WorldClim_2.1_FIO-ESM-2-0_ssp585_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jul,max T Jul,july,degrees Celsius,*degree*C*, +temperature_max_08,temperature_max_08,WorldClim_2.1_FIO-ESM-2-0_ssp585_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Aug,max T Aug,august,degrees Celsius,*degree*C*, +temperature_max_09,temperature_max_09,WorldClim_2.1_FIO-ESM-2-0_ssp585_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Sep,max T Sep,september,degrees Celsius,*degree*C*, +temperature_max_10,temperature_max_10,WorldClim_2.1_FIO-ESM-2-0_ssp585_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Oct,max T Oct,october,degrees Celsius,*degree*C*, +temperature_max_11,temperature_max_11,WorldClim_2.1_FIO-ESM-2-0_ssp585_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Nov,max T Nov,november,degrees Celsius,*degree*C*, +temperature_max_12,temperature_max_12,WorldClim_2.1_FIO-ESM-2-0_ssp585_10m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Dec,max T Dec,december,degrees Celsius,*degree*C*, +bio01,bio01,WorldClim_2.1_FIO-ESM-2-0_ssp585_5m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual mean temperature,ann. mean T,year,degrees Celsius,*degree*C*, +bio02,bio02,WorldClim_2.1_FIO-ESM-2-0_ssp585_5m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean diurnal range,diurn. range,year,degrees Celsius,*degree*C*, +bio03,bio03,WorldClim_2.1_FIO-ESM-2-0_ssp585_5m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,isothermality,isothermality,year,,, +bio04,bio04,WorldClim_2.1_FIO-ESM-2-0_ssp585_5m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature seasonality,T season.,year,degrees Celsius,*degree*C*, +bio05,bio05,WorldClim_2.1_FIO-ESM-2-0_ssp585_5m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature of warmest month,max. T of warmest mo.,year,degrees Celsius,*degree*C*, +bio06,bio06,WorldClim_2.1_FIO-ESM-2-0_ssp585_5m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature of coldest month,min. T of coldest mo.,year,degrees Celsius,*degree*C*, +bio07,bio07,WorldClim_2.1_FIO-ESM-2-0_ssp585_5m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature annual range (bio05-bio06),T ann. Range,year,degrees Celsius,*degree*C*, +bio08,bio08,WorldClim_2.1_FIO-ESM-2-0_ssp585_5m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of wettest quarter,mean T of wettest qtr,year,degrees Celsius,*degree*C*, +bio09,bio09,WorldClim_2.1_FIO-ESM-2-0_ssp585_5m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of driest quarter,mean T of driest qtr,year,degrees Celsius,*degree*C*, +bio10,bio10,WorldClim_2.1_FIO-ESM-2-0_ssp585_5m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of warmest quarter,mean T of warmest qtr,year,degrees Celsius,*degree*C*, +bio11,bio11,WorldClim_2.1_FIO-ESM-2-0_ssp585_5m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of coldest quarter,mean T of coldest qtr,year,degrees Celsius,*degree*C*, +bio12,bio12,WorldClim_2.1_FIO-ESM-2-0_ssp585_5m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual precipitation,ann. P,year,mm per year,*mm~yr^-1*, +bio13,bio13,WorldClim_2.1_FIO-ESM-2-0_ssp585_5m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest month,P of wettest mo.,year,mm per month,*mm~mo^-1*, +bio14,bio14,WorldClim_2.1_FIO-ESM-2-0_ssp585_5m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest month,P of driest mo.,year,mm per month,*mm~mo^-1*, +bio15,bio15,WorldClim_2.1_FIO-ESM-2-0_ssp585_5m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation seasonality (coeff var),P season.,year,,, +bio16,bio16,WorldClim_2.1_FIO-ESM-2-0_ssp585_5m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest quarter,P of wettest qtr,year,mm per quarter,*mm~qtr^-1*, +bio17,bio17,WorldClim_2.1_FIO-ESM-2-0_ssp585_5m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest quarter,P of driest qtr,year,mm per quarter,*mm~qtr^-1*, +bio18,bio18,WorldClim_2.1_FIO-ESM-2-0_ssp585_5m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of warmest quarter,P of warmest qtr,year,mm per quarter,*mm~qtr^-1*, +bio19,bio19,WorldClim_2.1_FIO-ESM-2-0_ssp585_5m,FALSE,WorldClim_2.1_FIO-ESM-2-0_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of coldest quarter,P of coldest qtr,year,mm per quarter,*mm~qtr^-1*, +precipitation_01,precipitation_01,WorldClim_2.1_FIO-ESM-2-0_ssp585_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jan,P Jan,january,mm per month,*mm~mo^-1*, +precipitation_02,precipitation_02,WorldClim_2.1_FIO-ESM-2-0_ssp585_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Feb,P Feb,february,mm per month,*mm~mo^-1*, +precipitation_03,precipitation_03,WorldClim_2.1_FIO-ESM-2-0_ssp585_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Mar,P Mar,march,mm per month,*mm~mo^-1*, +precipitation_04,precipitation_04,WorldClim_2.1_FIO-ESM-2-0_ssp585_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Apr,P Apr,april,mm per month,*mm~mo^-1*, +precipitation_05,precipitation_05,WorldClim_2.1_FIO-ESM-2-0_ssp585_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation May,P May,may,mm per month,*mm~mo^-1*, +precipitation_06,precipitation_06,WorldClim_2.1_FIO-ESM-2-0_ssp585_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jun,P Jun,june,mm per month,*mm~mo^-1*, +precipitation_07,precipitation_07,WorldClim_2.1_FIO-ESM-2-0_ssp585_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jul,P Jul,july,mm per month,*mm~mo^-1*, +precipitation_08,precipitation_08,WorldClim_2.1_FIO-ESM-2-0_ssp585_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Aug,P Aug,august,mm per month,*mm~mo^-1*, +precipitation_09,precipitation_09,WorldClim_2.1_FIO-ESM-2-0_ssp585_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Sep,P Sep,september,mm per month,*mm~mo^-1*, +precipitation_10,precipitation_10,WorldClim_2.1_FIO-ESM-2-0_ssp585_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Oct,P Oct,october,mm per month,*mm~mo^-1*, +precipitation_11,precipitation_11,WorldClim_2.1_FIO-ESM-2-0_ssp585_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Nov,P Nov,november,mm per month,*mm~mo^-1*, +precipitation_12,precipitation_12,WorldClim_2.1_FIO-ESM-2-0_ssp585_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Dec,P Dec,december,mm per month,*mm~mo^-1*, +temperature_min_01,temperature_min_01,WorldClim_2.1_FIO-ESM-2-0_ssp585_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jan,min T Jan,january,degrees Celsius,*degree*C*, +temperature_min_02,temperature_min_02,WorldClim_2.1_FIO-ESM-2-0_ssp585_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Feb,min T Feb,february,degrees Celsius,*degree*C*, +temperature_min_03,temperature_min_03,WorldClim_2.1_FIO-ESM-2-0_ssp585_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Mar,min T Mar,march,degrees Celsius,*degree*C*, +temperature_min_04,temperature_min_04,WorldClim_2.1_FIO-ESM-2-0_ssp585_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Apr,min T Apr,april,degrees Celsius,*degree*C*, +temperature_min_05,temperature_min_05,WorldClim_2.1_FIO-ESM-2-0_ssp585_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature May,min T May,may,degrees Celsius,*degree*C*, +temperature_min_06,temperature_min_06,WorldClim_2.1_FIO-ESM-2-0_ssp585_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jun,min T Jun,june,degrees Celsius,*degree*C*, +temperature_min_07,temperature_min_07,WorldClim_2.1_FIO-ESM-2-0_ssp585_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jul,min T Jul,july,degrees Celsius,*degree*C*, +temperature_min_08,temperature_min_08,WorldClim_2.1_FIO-ESM-2-0_ssp585_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Aug,min T Aug,august,degrees Celsius,*degree*C*, +temperature_min_09,temperature_min_09,WorldClim_2.1_FIO-ESM-2-0_ssp585_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Sep,min T Sep,september,degrees Celsius,*degree*C*, +temperature_min_10,temperature_min_10,WorldClim_2.1_FIO-ESM-2-0_ssp585_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Oct,min T Oct,october,degrees Celsius,*degree*C*, +temperature_min_11,temperature_min_11,WorldClim_2.1_FIO-ESM-2-0_ssp585_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Nov,min T Nov,november,degrees Celsius,*degree*C*, +temperature_min_12,temperature_min_12,WorldClim_2.1_FIO-ESM-2-0_ssp585_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Dec,min T Dec,december,degrees Celsius,*degree*C*, +temperature_max_01,temperature_max_01,WorldClim_2.1_FIO-ESM-2-0_ssp585_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jan,max T Jan,january,degrees Celsius,*degree*C*, +temperature_max_02,temperature_max_02,WorldClim_2.1_FIO-ESM-2-0_ssp585_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Feb,max T Feb,february,degrees Celsius,*degree*C*, +temperature_max_03,temperature_max_03,WorldClim_2.1_FIO-ESM-2-0_ssp585_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Mar,max T Mar,march,degrees Celsius,*degree*C*, +temperature_max_04,temperature_max_04,WorldClim_2.1_FIO-ESM-2-0_ssp585_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Apr,max T Apr,april,degrees Celsius,*degree*C*, +temperature_max_05,temperature_max_05,WorldClim_2.1_FIO-ESM-2-0_ssp585_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature May,max T May,may,degrees Celsius,*degree*C*, +temperature_max_06,temperature_max_06,WorldClim_2.1_FIO-ESM-2-0_ssp585_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jun,max T Jun,june,degrees Celsius,*degree*C*, +temperature_max_07,temperature_max_07,WorldClim_2.1_FIO-ESM-2-0_ssp585_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jul,max T Jul,july,degrees Celsius,*degree*C*, +temperature_max_08,temperature_max_08,WorldClim_2.1_FIO-ESM-2-0_ssp585_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Aug,max T Aug,august,degrees Celsius,*degree*C*, +temperature_max_09,temperature_max_09,WorldClim_2.1_FIO-ESM-2-0_ssp585_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Sep,max T Sep,september,degrees Celsius,*degree*C*, +temperature_max_10,temperature_max_10,WorldClim_2.1_FIO-ESM-2-0_ssp585_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Oct,max T Oct,october,degrees Celsius,*degree*C*, +temperature_max_11,temperature_max_11,WorldClim_2.1_FIO-ESM-2-0_ssp585_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Nov,max T Nov,november,degrees Celsius,*degree*C*, +temperature_max_12,temperature_max_12,WorldClim_2.1_FIO-ESM-2-0_ssp585_5m,TRUE,WorldClim_2.1_FIO-ESM-2-0_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Dec,max T Dec,december,degrees Celsius,*degree*C*, +bio01,bio01,WorldClim_2.1_GFDL-ESM4_ssp126_10m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual mean temperature,ann. mean T,year,degrees Celsius,*degree*C*, +bio02,bio02,WorldClim_2.1_GFDL-ESM4_ssp126_10m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean diurnal range,diurn. range,year,degrees Celsius,*degree*C*, +bio03,bio03,WorldClim_2.1_GFDL-ESM4_ssp126_10m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,isothermality,isothermality,year,,, +bio04,bio04,WorldClim_2.1_GFDL-ESM4_ssp126_10m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature seasonality,T season.,year,degrees Celsius,*degree*C*, +bio05,bio05,WorldClim_2.1_GFDL-ESM4_ssp126_10m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature of warmest month,max. T of warmest mo.,year,degrees Celsius,*degree*C*, +bio06,bio06,WorldClim_2.1_GFDL-ESM4_ssp126_10m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature of coldest month,min. T of coldest mo.,year,degrees Celsius,*degree*C*, +bio07,bio07,WorldClim_2.1_GFDL-ESM4_ssp126_10m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature annual range (bio05-bio06),T ann. Range,year,degrees Celsius,*degree*C*, +bio08,bio08,WorldClim_2.1_GFDL-ESM4_ssp126_10m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of wettest quarter,mean T of wettest qtr,year,degrees Celsius,*degree*C*, +bio09,bio09,WorldClim_2.1_GFDL-ESM4_ssp126_10m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of driest quarter,mean T of driest qtr,year,degrees Celsius,*degree*C*, +bio10,bio10,WorldClim_2.1_GFDL-ESM4_ssp126_10m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of warmest quarter,mean T of warmest qtr,year,degrees Celsius,*degree*C*, +bio11,bio11,WorldClim_2.1_GFDL-ESM4_ssp126_10m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of coldest quarter,mean T of coldest qtr,year,degrees Celsius,*degree*C*, +bio12,bio12,WorldClim_2.1_GFDL-ESM4_ssp126_10m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual precipitation,ann. P,year,mm per year,*mm~yr^-1*, +bio13,bio13,WorldClim_2.1_GFDL-ESM4_ssp126_10m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest month,P of wettest mo.,year,mm per month,*mm~mo^-1*, +bio14,bio14,WorldClim_2.1_GFDL-ESM4_ssp126_10m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest month,P of driest mo.,year,mm per month,*mm~mo^-1*, +bio15,bio15,WorldClim_2.1_GFDL-ESM4_ssp126_10m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation seasonality (coeff var),P season.,year,,, +bio16,bio16,WorldClim_2.1_GFDL-ESM4_ssp126_10m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest quarter,P of wettest qtr,year,mm per quarter,*mm~qtr^-1*, +bio17,bio17,WorldClim_2.1_GFDL-ESM4_ssp126_10m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest quarter,P of driest qtr,year,mm per quarter,*mm~qtr^-1*, +bio18,bio18,WorldClim_2.1_GFDL-ESM4_ssp126_10m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of warmest quarter,P of warmest qtr,year,mm per quarter,*mm~qtr^-1*, +bio19,bio19,WorldClim_2.1_GFDL-ESM4_ssp126_10m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of coldest quarter,P of coldest qtr,year,mm per quarter,*mm~qtr^-1*, +precipitation_01,precipitation_01,WorldClim_2.1_GFDL-ESM4_ssp126_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jan,P Jan,january,mm per month,*mm~mo^-1*, +precipitation_02,precipitation_02,WorldClim_2.1_GFDL-ESM4_ssp126_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Feb,P Feb,february,mm per month,*mm~mo^-1*, +precipitation_03,precipitation_03,WorldClim_2.1_GFDL-ESM4_ssp126_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Mar,P Mar,march,mm per month,*mm~mo^-1*, +precipitation_04,precipitation_04,WorldClim_2.1_GFDL-ESM4_ssp126_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Apr,P Apr,april,mm per month,*mm~mo^-1*, +precipitation_05,precipitation_05,WorldClim_2.1_GFDL-ESM4_ssp126_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation May,P May,may,mm per month,*mm~mo^-1*, +precipitation_06,precipitation_06,WorldClim_2.1_GFDL-ESM4_ssp126_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jun,P Jun,june,mm per month,*mm~mo^-1*, +precipitation_07,precipitation_07,WorldClim_2.1_GFDL-ESM4_ssp126_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jul,P Jul,july,mm per month,*mm~mo^-1*, +precipitation_08,precipitation_08,WorldClim_2.1_GFDL-ESM4_ssp126_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Aug,P Aug,august,mm per month,*mm~mo^-1*, +precipitation_09,precipitation_09,WorldClim_2.1_GFDL-ESM4_ssp126_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Sep,P Sep,september,mm per month,*mm~mo^-1*, +precipitation_10,precipitation_10,WorldClim_2.1_GFDL-ESM4_ssp126_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Oct,P Oct,october,mm per month,*mm~mo^-1*, +precipitation_11,precipitation_11,WorldClim_2.1_GFDL-ESM4_ssp126_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Nov,P Nov,november,mm per month,*mm~mo^-1*, +precipitation_12,precipitation_12,WorldClim_2.1_GFDL-ESM4_ssp126_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Dec,P Dec,december,mm per month,*mm~mo^-1*, +temperature_min_01,temperature_min_01,WorldClim_2.1_GFDL-ESM4_ssp126_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jan,min T Jan,january,degrees Celsius,*degree*C*, +temperature_min_02,temperature_min_02,WorldClim_2.1_GFDL-ESM4_ssp126_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Feb,min T Feb,february,degrees Celsius,*degree*C*, +temperature_min_03,temperature_min_03,WorldClim_2.1_GFDL-ESM4_ssp126_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Mar,min T Mar,march,degrees Celsius,*degree*C*, +temperature_min_04,temperature_min_04,WorldClim_2.1_GFDL-ESM4_ssp126_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Apr,min T Apr,april,degrees Celsius,*degree*C*, +temperature_min_05,temperature_min_05,WorldClim_2.1_GFDL-ESM4_ssp126_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature May,min T May,may,degrees Celsius,*degree*C*, +temperature_min_06,temperature_min_06,WorldClim_2.1_GFDL-ESM4_ssp126_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jun,min T Jun,june,degrees Celsius,*degree*C*, +temperature_min_07,temperature_min_07,WorldClim_2.1_GFDL-ESM4_ssp126_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jul,min T Jul,july,degrees Celsius,*degree*C*, +temperature_min_08,temperature_min_08,WorldClim_2.1_GFDL-ESM4_ssp126_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Aug,min T Aug,august,degrees Celsius,*degree*C*, +temperature_min_09,temperature_min_09,WorldClim_2.1_GFDL-ESM4_ssp126_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Sep,min T Sep,september,degrees Celsius,*degree*C*, +temperature_min_10,temperature_min_10,WorldClim_2.1_GFDL-ESM4_ssp126_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Oct,min T Oct,october,degrees Celsius,*degree*C*, +temperature_min_11,temperature_min_11,WorldClim_2.1_GFDL-ESM4_ssp126_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Nov,min T Nov,november,degrees Celsius,*degree*C*, +temperature_min_12,temperature_min_12,WorldClim_2.1_GFDL-ESM4_ssp126_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Dec,min T Dec,december,degrees Celsius,*degree*C*, +temperature_max_01,temperature_max_01,WorldClim_2.1_GFDL-ESM4_ssp126_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jan,max T Jan,january,degrees Celsius,*degree*C*, +temperature_max_02,temperature_max_02,WorldClim_2.1_GFDL-ESM4_ssp126_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Feb,max T Feb,february,degrees Celsius,*degree*C*, +temperature_max_03,temperature_max_03,WorldClim_2.1_GFDL-ESM4_ssp126_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Mar,max T Mar,march,degrees Celsius,*degree*C*, +temperature_max_04,temperature_max_04,WorldClim_2.1_GFDL-ESM4_ssp126_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Apr,max T Apr,april,degrees Celsius,*degree*C*, +temperature_max_05,temperature_max_05,WorldClim_2.1_GFDL-ESM4_ssp126_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature May,max T May,may,degrees Celsius,*degree*C*, +temperature_max_06,temperature_max_06,WorldClim_2.1_GFDL-ESM4_ssp126_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jun,max T Jun,june,degrees Celsius,*degree*C*, +temperature_max_07,temperature_max_07,WorldClim_2.1_GFDL-ESM4_ssp126_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jul,max T Jul,july,degrees Celsius,*degree*C*, +temperature_max_08,temperature_max_08,WorldClim_2.1_GFDL-ESM4_ssp126_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Aug,max T Aug,august,degrees Celsius,*degree*C*, +temperature_max_09,temperature_max_09,WorldClim_2.1_GFDL-ESM4_ssp126_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Sep,max T Sep,september,degrees Celsius,*degree*C*, +temperature_max_10,temperature_max_10,WorldClim_2.1_GFDL-ESM4_ssp126_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Oct,max T Oct,october,degrees Celsius,*degree*C*, +temperature_max_11,temperature_max_11,WorldClim_2.1_GFDL-ESM4_ssp126_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Nov,max T Nov,november,degrees Celsius,*degree*C*, +temperature_max_12,temperature_max_12,WorldClim_2.1_GFDL-ESM4_ssp126_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Dec,max T Dec,december,degrees Celsius,*degree*C*, +bio01,bio01,WorldClim_2.1_GFDL-ESM4_ssp126_5m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual mean temperature,ann. mean T,year,degrees Celsius,*degree*C*, +bio02,bio02,WorldClim_2.1_GFDL-ESM4_ssp126_5m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean diurnal range,diurn. range,year,degrees Celsius,*degree*C*, +bio03,bio03,WorldClim_2.1_GFDL-ESM4_ssp126_5m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,isothermality,isothermality,year,,, +bio04,bio04,WorldClim_2.1_GFDL-ESM4_ssp126_5m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature seasonality,T season.,year,degrees Celsius,*degree*C*, +bio05,bio05,WorldClim_2.1_GFDL-ESM4_ssp126_5m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature of warmest month,max. T of warmest mo.,year,degrees Celsius,*degree*C*, +bio06,bio06,WorldClim_2.1_GFDL-ESM4_ssp126_5m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature of coldest month,min. T of coldest mo.,year,degrees Celsius,*degree*C*, +bio07,bio07,WorldClim_2.1_GFDL-ESM4_ssp126_5m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature annual range (bio05-bio06),T ann. Range,year,degrees Celsius,*degree*C*, +bio08,bio08,WorldClim_2.1_GFDL-ESM4_ssp126_5m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of wettest quarter,mean T of wettest qtr,year,degrees Celsius,*degree*C*, +bio09,bio09,WorldClim_2.1_GFDL-ESM4_ssp126_5m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of driest quarter,mean T of driest qtr,year,degrees Celsius,*degree*C*, +bio10,bio10,WorldClim_2.1_GFDL-ESM4_ssp126_5m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of warmest quarter,mean T of warmest qtr,year,degrees Celsius,*degree*C*, +bio11,bio11,WorldClim_2.1_GFDL-ESM4_ssp126_5m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of coldest quarter,mean T of coldest qtr,year,degrees Celsius,*degree*C*, +bio12,bio12,WorldClim_2.1_GFDL-ESM4_ssp126_5m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual precipitation,ann. P,year,mm per year,*mm~yr^-1*, +bio13,bio13,WorldClim_2.1_GFDL-ESM4_ssp126_5m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest month,P of wettest mo.,year,mm per month,*mm~mo^-1*, +bio14,bio14,WorldClim_2.1_GFDL-ESM4_ssp126_5m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest month,P of driest mo.,year,mm per month,*mm~mo^-1*, +bio15,bio15,WorldClim_2.1_GFDL-ESM4_ssp126_5m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation seasonality (coeff var),P season.,year,,, +bio16,bio16,WorldClim_2.1_GFDL-ESM4_ssp126_5m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest quarter,P of wettest qtr,year,mm per quarter,*mm~qtr^-1*, +bio17,bio17,WorldClim_2.1_GFDL-ESM4_ssp126_5m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest quarter,P of driest qtr,year,mm per quarter,*mm~qtr^-1*, +bio18,bio18,WorldClim_2.1_GFDL-ESM4_ssp126_5m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of warmest quarter,P of warmest qtr,year,mm per quarter,*mm~qtr^-1*, +bio19,bio19,WorldClim_2.1_GFDL-ESM4_ssp126_5m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of coldest quarter,P of coldest qtr,year,mm per quarter,*mm~qtr^-1*, +precipitation_01,precipitation_01,WorldClim_2.1_GFDL-ESM4_ssp126_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jan,P Jan,january,mm per month,*mm~mo^-1*, +precipitation_02,precipitation_02,WorldClim_2.1_GFDL-ESM4_ssp126_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Feb,P Feb,february,mm per month,*mm~mo^-1*, +precipitation_03,precipitation_03,WorldClim_2.1_GFDL-ESM4_ssp126_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Mar,P Mar,march,mm per month,*mm~mo^-1*, +precipitation_04,precipitation_04,WorldClim_2.1_GFDL-ESM4_ssp126_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Apr,P Apr,april,mm per month,*mm~mo^-1*, +precipitation_05,precipitation_05,WorldClim_2.1_GFDL-ESM4_ssp126_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation May,P May,may,mm per month,*mm~mo^-1*, +precipitation_06,precipitation_06,WorldClim_2.1_GFDL-ESM4_ssp126_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jun,P Jun,june,mm per month,*mm~mo^-1*, +precipitation_07,precipitation_07,WorldClim_2.1_GFDL-ESM4_ssp126_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jul,P Jul,july,mm per month,*mm~mo^-1*, +precipitation_08,precipitation_08,WorldClim_2.1_GFDL-ESM4_ssp126_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Aug,P Aug,august,mm per month,*mm~mo^-1*, +precipitation_09,precipitation_09,WorldClim_2.1_GFDL-ESM4_ssp126_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Sep,P Sep,september,mm per month,*mm~mo^-1*, +precipitation_10,precipitation_10,WorldClim_2.1_GFDL-ESM4_ssp126_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Oct,P Oct,october,mm per month,*mm~mo^-1*, +precipitation_11,precipitation_11,WorldClim_2.1_GFDL-ESM4_ssp126_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Nov,P Nov,november,mm per month,*mm~mo^-1*, +precipitation_12,precipitation_12,WorldClim_2.1_GFDL-ESM4_ssp126_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Dec,P Dec,december,mm per month,*mm~mo^-1*, +temperature_min_01,temperature_min_01,WorldClim_2.1_GFDL-ESM4_ssp126_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jan,min T Jan,january,degrees Celsius,*degree*C*, +temperature_min_02,temperature_min_02,WorldClim_2.1_GFDL-ESM4_ssp126_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Feb,min T Feb,february,degrees Celsius,*degree*C*, +temperature_min_03,temperature_min_03,WorldClim_2.1_GFDL-ESM4_ssp126_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Mar,min T Mar,march,degrees Celsius,*degree*C*, +temperature_min_04,temperature_min_04,WorldClim_2.1_GFDL-ESM4_ssp126_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Apr,min T Apr,april,degrees Celsius,*degree*C*, +temperature_min_05,temperature_min_05,WorldClim_2.1_GFDL-ESM4_ssp126_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature May,min T May,may,degrees Celsius,*degree*C*, +temperature_min_06,temperature_min_06,WorldClim_2.1_GFDL-ESM4_ssp126_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jun,min T Jun,june,degrees Celsius,*degree*C*, +temperature_min_07,temperature_min_07,WorldClim_2.1_GFDL-ESM4_ssp126_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jul,min T Jul,july,degrees Celsius,*degree*C*, +temperature_min_08,temperature_min_08,WorldClim_2.1_GFDL-ESM4_ssp126_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Aug,min T Aug,august,degrees Celsius,*degree*C*, +temperature_min_09,temperature_min_09,WorldClim_2.1_GFDL-ESM4_ssp126_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Sep,min T Sep,september,degrees Celsius,*degree*C*, +temperature_min_10,temperature_min_10,WorldClim_2.1_GFDL-ESM4_ssp126_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Oct,min T Oct,october,degrees Celsius,*degree*C*, +temperature_min_11,temperature_min_11,WorldClim_2.1_GFDL-ESM4_ssp126_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Nov,min T Nov,november,degrees Celsius,*degree*C*, +temperature_min_12,temperature_min_12,WorldClim_2.1_GFDL-ESM4_ssp126_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Dec,min T Dec,december,degrees Celsius,*degree*C*, +temperature_max_01,temperature_max_01,WorldClim_2.1_GFDL-ESM4_ssp126_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jan,max T Jan,january,degrees Celsius,*degree*C*, +temperature_max_02,temperature_max_02,WorldClim_2.1_GFDL-ESM4_ssp126_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Feb,max T Feb,february,degrees Celsius,*degree*C*, +temperature_max_03,temperature_max_03,WorldClim_2.1_GFDL-ESM4_ssp126_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Mar,max T Mar,march,degrees Celsius,*degree*C*, +temperature_max_04,temperature_max_04,WorldClim_2.1_GFDL-ESM4_ssp126_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Apr,max T Apr,april,degrees Celsius,*degree*C*, +temperature_max_05,temperature_max_05,WorldClim_2.1_GFDL-ESM4_ssp126_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature May,max T May,may,degrees Celsius,*degree*C*, +temperature_max_06,temperature_max_06,WorldClim_2.1_GFDL-ESM4_ssp126_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jun,max T Jun,june,degrees Celsius,*degree*C*, +temperature_max_07,temperature_max_07,WorldClim_2.1_GFDL-ESM4_ssp126_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jul,max T Jul,july,degrees Celsius,*degree*C*, +temperature_max_08,temperature_max_08,WorldClim_2.1_GFDL-ESM4_ssp126_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Aug,max T Aug,august,degrees Celsius,*degree*C*, +temperature_max_09,temperature_max_09,WorldClim_2.1_GFDL-ESM4_ssp126_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Sep,max T Sep,september,degrees Celsius,*degree*C*, +temperature_max_10,temperature_max_10,WorldClim_2.1_GFDL-ESM4_ssp126_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Oct,max T Oct,october,degrees Celsius,*degree*C*, +temperature_max_11,temperature_max_11,WorldClim_2.1_GFDL-ESM4_ssp126_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Nov,max T Nov,november,degrees Celsius,*degree*C*, +temperature_max_12,temperature_max_12,WorldClim_2.1_GFDL-ESM4_ssp126_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Dec,max T Dec,december,degrees Celsius,*degree*C*, +bio01,bio01,WorldClim_2.1_GFDL-ESM4_ssp245_10m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual mean temperature,ann. mean T,year,degrees Celsius,*degree*C*, +bio02,bio02,WorldClim_2.1_GFDL-ESM4_ssp245_10m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean diurnal range,diurn. range,year,degrees Celsius,*degree*C*, +bio03,bio03,WorldClim_2.1_GFDL-ESM4_ssp245_10m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,isothermality,isothermality,year,,, +bio04,bio04,WorldClim_2.1_GFDL-ESM4_ssp245_10m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature seasonality,T season.,year,degrees Celsius,*degree*C*, +bio05,bio05,WorldClim_2.1_GFDL-ESM4_ssp245_10m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature of warmest month,max. T of warmest mo.,year,degrees Celsius,*degree*C*, +bio06,bio06,WorldClim_2.1_GFDL-ESM4_ssp245_10m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature of coldest month,min. T of coldest mo.,year,degrees Celsius,*degree*C*, +bio07,bio07,WorldClim_2.1_GFDL-ESM4_ssp245_10m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature annual range (bio05-bio06),T ann. Range,year,degrees Celsius,*degree*C*, +bio08,bio08,WorldClim_2.1_GFDL-ESM4_ssp245_10m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of wettest quarter,mean T of wettest qtr,year,degrees Celsius,*degree*C*, +bio09,bio09,WorldClim_2.1_GFDL-ESM4_ssp245_10m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of driest quarter,mean T of driest qtr,year,degrees Celsius,*degree*C*, +bio10,bio10,WorldClim_2.1_GFDL-ESM4_ssp245_10m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of warmest quarter,mean T of warmest qtr,year,degrees Celsius,*degree*C*, +bio11,bio11,WorldClim_2.1_GFDL-ESM4_ssp245_10m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of coldest quarter,mean T of coldest qtr,year,degrees Celsius,*degree*C*, +bio12,bio12,WorldClim_2.1_GFDL-ESM4_ssp245_10m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual precipitation,ann. P,year,mm per year,*mm~yr^-1*, +bio13,bio13,WorldClim_2.1_GFDL-ESM4_ssp245_10m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest month,P of wettest mo.,year,mm per month,*mm~mo^-1*, +bio14,bio14,WorldClim_2.1_GFDL-ESM4_ssp245_10m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest month,P of driest mo.,year,mm per month,*mm~mo^-1*, +bio15,bio15,WorldClim_2.1_GFDL-ESM4_ssp245_10m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation seasonality (coeff var),P season.,year,,, +bio16,bio16,WorldClim_2.1_GFDL-ESM4_ssp245_10m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest quarter,P of wettest qtr,year,mm per quarter,*mm~qtr^-1*, +bio17,bio17,WorldClim_2.1_GFDL-ESM4_ssp245_10m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest quarter,P of driest qtr,year,mm per quarter,*mm~qtr^-1*, +bio18,bio18,WorldClim_2.1_GFDL-ESM4_ssp245_10m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of warmest quarter,P of warmest qtr,year,mm per quarter,*mm~qtr^-1*, +bio19,bio19,WorldClim_2.1_GFDL-ESM4_ssp245_10m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of coldest quarter,P of coldest qtr,year,mm per quarter,*mm~qtr^-1*, +precipitation_01,precipitation_01,WorldClim_2.1_GFDL-ESM4_ssp245_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jan,P Jan,january,mm per month,*mm~mo^-1*, +precipitation_02,precipitation_02,WorldClim_2.1_GFDL-ESM4_ssp245_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Feb,P Feb,february,mm per month,*mm~mo^-1*, +precipitation_03,precipitation_03,WorldClim_2.1_GFDL-ESM4_ssp245_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Mar,P Mar,march,mm per month,*mm~mo^-1*, +precipitation_04,precipitation_04,WorldClim_2.1_GFDL-ESM4_ssp245_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Apr,P Apr,april,mm per month,*mm~mo^-1*, +precipitation_05,precipitation_05,WorldClim_2.1_GFDL-ESM4_ssp245_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation May,P May,may,mm per month,*mm~mo^-1*, +precipitation_06,precipitation_06,WorldClim_2.1_GFDL-ESM4_ssp245_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jun,P Jun,june,mm per month,*mm~mo^-1*, +precipitation_07,precipitation_07,WorldClim_2.1_GFDL-ESM4_ssp245_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jul,P Jul,july,mm per month,*mm~mo^-1*, +precipitation_08,precipitation_08,WorldClim_2.1_GFDL-ESM4_ssp245_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Aug,P Aug,august,mm per month,*mm~mo^-1*, +precipitation_09,precipitation_09,WorldClim_2.1_GFDL-ESM4_ssp245_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Sep,P Sep,september,mm per month,*mm~mo^-1*, +precipitation_10,precipitation_10,WorldClim_2.1_GFDL-ESM4_ssp245_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Oct,P Oct,october,mm per month,*mm~mo^-1*, +precipitation_11,precipitation_11,WorldClim_2.1_GFDL-ESM4_ssp245_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Nov,P Nov,november,mm per month,*mm~mo^-1*, +precipitation_12,precipitation_12,WorldClim_2.1_GFDL-ESM4_ssp245_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Dec,P Dec,december,mm per month,*mm~mo^-1*, +temperature_min_01,temperature_min_01,WorldClim_2.1_GFDL-ESM4_ssp245_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jan,min T Jan,january,degrees Celsius,*degree*C*, +temperature_min_02,temperature_min_02,WorldClim_2.1_GFDL-ESM4_ssp245_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Feb,min T Feb,february,degrees Celsius,*degree*C*, +temperature_min_03,temperature_min_03,WorldClim_2.1_GFDL-ESM4_ssp245_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Mar,min T Mar,march,degrees Celsius,*degree*C*, +temperature_min_04,temperature_min_04,WorldClim_2.1_GFDL-ESM4_ssp245_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Apr,min T Apr,april,degrees Celsius,*degree*C*, +temperature_min_05,temperature_min_05,WorldClim_2.1_GFDL-ESM4_ssp245_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature May,min T May,may,degrees Celsius,*degree*C*, +temperature_min_06,temperature_min_06,WorldClim_2.1_GFDL-ESM4_ssp245_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jun,min T Jun,june,degrees Celsius,*degree*C*, +temperature_min_07,temperature_min_07,WorldClim_2.1_GFDL-ESM4_ssp245_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jul,min T Jul,july,degrees Celsius,*degree*C*, +temperature_min_08,temperature_min_08,WorldClim_2.1_GFDL-ESM4_ssp245_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Aug,min T Aug,august,degrees Celsius,*degree*C*, +temperature_min_09,temperature_min_09,WorldClim_2.1_GFDL-ESM4_ssp245_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Sep,min T Sep,september,degrees Celsius,*degree*C*, +temperature_min_10,temperature_min_10,WorldClim_2.1_GFDL-ESM4_ssp245_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Oct,min T Oct,october,degrees Celsius,*degree*C*, +temperature_min_11,temperature_min_11,WorldClim_2.1_GFDL-ESM4_ssp245_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Nov,min T Nov,november,degrees Celsius,*degree*C*, +temperature_min_12,temperature_min_12,WorldClim_2.1_GFDL-ESM4_ssp245_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Dec,min T Dec,december,degrees Celsius,*degree*C*, +temperature_max_01,temperature_max_01,WorldClim_2.1_GFDL-ESM4_ssp245_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jan,max T Jan,january,degrees Celsius,*degree*C*, +temperature_max_02,temperature_max_02,WorldClim_2.1_GFDL-ESM4_ssp245_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Feb,max T Feb,february,degrees Celsius,*degree*C*, +temperature_max_03,temperature_max_03,WorldClim_2.1_GFDL-ESM4_ssp245_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Mar,max T Mar,march,degrees Celsius,*degree*C*, +temperature_max_04,temperature_max_04,WorldClim_2.1_GFDL-ESM4_ssp245_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Apr,max T Apr,april,degrees Celsius,*degree*C*, +temperature_max_05,temperature_max_05,WorldClim_2.1_GFDL-ESM4_ssp245_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature May,max T May,may,degrees Celsius,*degree*C*, +temperature_max_06,temperature_max_06,WorldClim_2.1_GFDL-ESM4_ssp245_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jun,max T Jun,june,degrees Celsius,*degree*C*, +temperature_max_07,temperature_max_07,WorldClim_2.1_GFDL-ESM4_ssp245_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jul,max T Jul,july,degrees Celsius,*degree*C*, +temperature_max_08,temperature_max_08,WorldClim_2.1_GFDL-ESM4_ssp245_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Aug,max T Aug,august,degrees Celsius,*degree*C*, +temperature_max_09,temperature_max_09,WorldClim_2.1_GFDL-ESM4_ssp245_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Sep,max T Sep,september,degrees Celsius,*degree*C*, +temperature_max_10,temperature_max_10,WorldClim_2.1_GFDL-ESM4_ssp245_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Oct,max T Oct,october,degrees Celsius,*degree*C*, +temperature_max_11,temperature_max_11,WorldClim_2.1_GFDL-ESM4_ssp245_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Nov,max T Nov,november,degrees Celsius,*degree*C*, +temperature_max_12,temperature_max_12,WorldClim_2.1_GFDL-ESM4_ssp245_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Dec,max T Dec,december,degrees Celsius,*degree*C*, +bio01,bio01,WorldClim_2.1_GFDL-ESM4_ssp245_5m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual mean temperature,ann. mean T,year,degrees Celsius,*degree*C*, +bio02,bio02,WorldClim_2.1_GFDL-ESM4_ssp245_5m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean diurnal range,diurn. range,year,degrees Celsius,*degree*C*, +bio03,bio03,WorldClim_2.1_GFDL-ESM4_ssp245_5m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,isothermality,isothermality,year,,, +bio04,bio04,WorldClim_2.1_GFDL-ESM4_ssp245_5m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature seasonality,T season.,year,degrees Celsius,*degree*C*, +bio05,bio05,WorldClim_2.1_GFDL-ESM4_ssp245_5m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature of warmest month,max. T of warmest mo.,year,degrees Celsius,*degree*C*, +bio06,bio06,WorldClim_2.1_GFDL-ESM4_ssp245_5m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature of coldest month,min. T of coldest mo.,year,degrees Celsius,*degree*C*, +bio07,bio07,WorldClim_2.1_GFDL-ESM4_ssp245_5m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature annual range (bio05-bio06),T ann. Range,year,degrees Celsius,*degree*C*, +bio08,bio08,WorldClim_2.1_GFDL-ESM4_ssp245_5m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of wettest quarter,mean T of wettest qtr,year,degrees Celsius,*degree*C*, +bio09,bio09,WorldClim_2.1_GFDL-ESM4_ssp245_5m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of driest quarter,mean T of driest qtr,year,degrees Celsius,*degree*C*, +bio10,bio10,WorldClim_2.1_GFDL-ESM4_ssp245_5m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of warmest quarter,mean T of warmest qtr,year,degrees Celsius,*degree*C*, +bio11,bio11,WorldClim_2.1_GFDL-ESM4_ssp245_5m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of coldest quarter,mean T of coldest qtr,year,degrees Celsius,*degree*C*, +bio12,bio12,WorldClim_2.1_GFDL-ESM4_ssp245_5m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual precipitation,ann. P,year,mm per year,*mm~yr^-1*, +bio13,bio13,WorldClim_2.1_GFDL-ESM4_ssp245_5m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest month,P of wettest mo.,year,mm per month,*mm~mo^-1*, +bio14,bio14,WorldClim_2.1_GFDL-ESM4_ssp245_5m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest month,P of driest mo.,year,mm per month,*mm~mo^-1*, +bio15,bio15,WorldClim_2.1_GFDL-ESM4_ssp245_5m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation seasonality (coeff var),P season.,year,,, +bio16,bio16,WorldClim_2.1_GFDL-ESM4_ssp245_5m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest quarter,P of wettest qtr,year,mm per quarter,*mm~qtr^-1*, +bio17,bio17,WorldClim_2.1_GFDL-ESM4_ssp245_5m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest quarter,P of driest qtr,year,mm per quarter,*mm~qtr^-1*, +bio18,bio18,WorldClim_2.1_GFDL-ESM4_ssp245_5m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of warmest quarter,P of warmest qtr,year,mm per quarter,*mm~qtr^-1*, +bio19,bio19,WorldClim_2.1_GFDL-ESM4_ssp245_5m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of coldest quarter,P of coldest qtr,year,mm per quarter,*mm~qtr^-1*, +precipitation_01,precipitation_01,WorldClim_2.1_GFDL-ESM4_ssp245_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jan,P Jan,january,mm per month,*mm~mo^-1*, +precipitation_02,precipitation_02,WorldClim_2.1_GFDL-ESM4_ssp245_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Feb,P Feb,february,mm per month,*mm~mo^-1*, +precipitation_03,precipitation_03,WorldClim_2.1_GFDL-ESM4_ssp245_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Mar,P Mar,march,mm per month,*mm~mo^-1*, +precipitation_04,precipitation_04,WorldClim_2.1_GFDL-ESM4_ssp245_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Apr,P Apr,april,mm per month,*mm~mo^-1*, +precipitation_05,precipitation_05,WorldClim_2.1_GFDL-ESM4_ssp245_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation May,P May,may,mm per month,*mm~mo^-1*, +precipitation_06,precipitation_06,WorldClim_2.1_GFDL-ESM4_ssp245_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jun,P Jun,june,mm per month,*mm~mo^-1*, +precipitation_07,precipitation_07,WorldClim_2.1_GFDL-ESM4_ssp245_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jul,P Jul,july,mm per month,*mm~mo^-1*, +precipitation_08,precipitation_08,WorldClim_2.1_GFDL-ESM4_ssp245_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Aug,P Aug,august,mm per month,*mm~mo^-1*, +precipitation_09,precipitation_09,WorldClim_2.1_GFDL-ESM4_ssp245_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Sep,P Sep,september,mm per month,*mm~mo^-1*, +precipitation_10,precipitation_10,WorldClim_2.1_GFDL-ESM4_ssp245_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Oct,P Oct,october,mm per month,*mm~mo^-1*, +precipitation_11,precipitation_11,WorldClim_2.1_GFDL-ESM4_ssp245_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Nov,P Nov,november,mm per month,*mm~mo^-1*, +precipitation_12,precipitation_12,WorldClim_2.1_GFDL-ESM4_ssp245_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Dec,P Dec,december,mm per month,*mm~mo^-1*, +temperature_min_01,temperature_min_01,WorldClim_2.1_GFDL-ESM4_ssp245_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jan,min T Jan,january,degrees Celsius,*degree*C*, +temperature_min_02,temperature_min_02,WorldClim_2.1_GFDL-ESM4_ssp245_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Feb,min T Feb,february,degrees Celsius,*degree*C*, +temperature_min_03,temperature_min_03,WorldClim_2.1_GFDL-ESM4_ssp245_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Mar,min T Mar,march,degrees Celsius,*degree*C*, +temperature_min_04,temperature_min_04,WorldClim_2.1_GFDL-ESM4_ssp245_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Apr,min T Apr,april,degrees Celsius,*degree*C*, +temperature_min_05,temperature_min_05,WorldClim_2.1_GFDL-ESM4_ssp245_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature May,min T May,may,degrees Celsius,*degree*C*, +temperature_min_06,temperature_min_06,WorldClim_2.1_GFDL-ESM4_ssp245_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jun,min T Jun,june,degrees Celsius,*degree*C*, +temperature_min_07,temperature_min_07,WorldClim_2.1_GFDL-ESM4_ssp245_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jul,min T Jul,july,degrees Celsius,*degree*C*, +temperature_min_08,temperature_min_08,WorldClim_2.1_GFDL-ESM4_ssp245_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Aug,min T Aug,august,degrees Celsius,*degree*C*, +temperature_min_09,temperature_min_09,WorldClim_2.1_GFDL-ESM4_ssp245_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Sep,min T Sep,september,degrees Celsius,*degree*C*, +temperature_min_10,temperature_min_10,WorldClim_2.1_GFDL-ESM4_ssp245_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Oct,min T Oct,october,degrees Celsius,*degree*C*, +temperature_min_11,temperature_min_11,WorldClim_2.1_GFDL-ESM4_ssp245_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Nov,min T Nov,november,degrees Celsius,*degree*C*, +temperature_min_12,temperature_min_12,WorldClim_2.1_GFDL-ESM4_ssp245_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Dec,min T Dec,december,degrees Celsius,*degree*C*, +temperature_max_01,temperature_max_01,WorldClim_2.1_GFDL-ESM4_ssp245_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jan,max T Jan,january,degrees Celsius,*degree*C*, +temperature_max_02,temperature_max_02,WorldClim_2.1_GFDL-ESM4_ssp245_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Feb,max T Feb,february,degrees Celsius,*degree*C*, +temperature_max_03,temperature_max_03,WorldClim_2.1_GFDL-ESM4_ssp245_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Mar,max T Mar,march,degrees Celsius,*degree*C*, +temperature_max_04,temperature_max_04,WorldClim_2.1_GFDL-ESM4_ssp245_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Apr,max T Apr,april,degrees Celsius,*degree*C*, +temperature_max_05,temperature_max_05,WorldClim_2.1_GFDL-ESM4_ssp245_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature May,max T May,may,degrees Celsius,*degree*C*, +temperature_max_06,temperature_max_06,WorldClim_2.1_GFDL-ESM4_ssp245_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jun,max T Jun,june,degrees Celsius,*degree*C*, +temperature_max_07,temperature_max_07,WorldClim_2.1_GFDL-ESM4_ssp245_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jul,max T Jul,july,degrees Celsius,*degree*C*, +temperature_max_08,temperature_max_08,WorldClim_2.1_GFDL-ESM4_ssp245_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Aug,max T Aug,august,degrees Celsius,*degree*C*, +temperature_max_09,temperature_max_09,WorldClim_2.1_GFDL-ESM4_ssp245_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Sep,max T Sep,september,degrees Celsius,*degree*C*, +temperature_max_10,temperature_max_10,WorldClim_2.1_GFDL-ESM4_ssp245_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Oct,max T Oct,october,degrees Celsius,*degree*C*, +temperature_max_11,temperature_max_11,WorldClim_2.1_GFDL-ESM4_ssp245_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Nov,max T Nov,november,degrees Celsius,*degree*C*, +temperature_max_12,temperature_max_12,WorldClim_2.1_GFDL-ESM4_ssp245_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Dec,max T Dec,december,degrees Celsius,*degree*C*, +bio01,bio01,WorldClim_2.1_GFDL-ESM4_ssp370_10m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual mean temperature,ann. mean T,year,degrees Celsius,*degree*C*, +bio02,bio02,WorldClim_2.1_GFDL-ESM4_ssp370_10m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean diurnal range,diurn. range,year,degrees Celsius,*degree*C*, +bio03,bio03,WorldClim_2.1_GFDL-ESM4_ssp370_10m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,isothermality,isothermality,year,,, +bio04,bio04,WorldClim_2.1_GFDL-ESM4_ssp370_10m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature seasonality,T season.,year,degrees Celsius,*degree*C*, +bio05,bio05,WorldClim_2.1_GFDL-ESM4_ssp370_10m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature of warmest month,max. T of warmest mo.,year,degrees Celsius,*degree*C*, +bio06,bio06,WorldClim_2.1_GFDL-ESM4_ssp370_10m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature of coldest month,min. T of coldest mo.,year,degrees Celsius,*degree*C*, +bio07,bio07,WorldClim_2.1_GFDL-ESM4_ssp370_10m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature annual range (bio05-bio06),T ann. Range,year,degrees Celsius,*degree*C*, +bio08,bio08,WorldClim_2.1_GFDL-ESM4_ssp370_10m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of wettest quarter,mean T of wettest qtr,year,degrees Celsius,*degree*C*, +bio09,bio09,WorldClim_2.1_GFDL-ESM4_ssp370_10m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of driest quarter,mean T of driest qtr,year,degrees Celsius,*degree*C*, +bio10,bio10,WorldClim_2.1_GFDL-ESM4_ssp370_10m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of warmest quarter,mean T of warmest qtr,year,degrees Celsius,*degree*C*, +bio11,bio11,WorldClim_2.1_GFDL-ESM4_ssp370_10m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of coldest quarter,mean T of coldest qtr,year,degrees Celsius,*degree*C*, +bio12,bio12,WorldClim_2.1_GFDL-ESM4_ssp370_10m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual precipitation,ann. P,year,mm per year,*mm~yr^-1*, +bio13,bio13,WorldClim_2.1_GFDL-ESM4_ssp370_10m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest month,P of wettest mo.,year,mm per month,*mm~mo^-1*, +bio14,bio14,WorldClim_2.1_GFDL-ESM4_ssp370_10m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest month,P of driest mo.,year,mm per month,*mm~mo^-1*, +bio15,bio15,WorldClim_2.1_GFDL-ESM4_ssp370_10m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation seasonality (coeff var),P season.,year,,, +bio16,bio16,WorldClim_2.1_GFDL-ESM4_ssp370_10m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest quarter,P of wettest qtr,year,mm per quarter,*mm~qtr^-1*, +bio17,bio17,WorldClim_2.1_GFDL-ESM4_ssp370_10m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest quarter,P of driest qtr,year,mm per quarter,*mm~qtr^-1*, +bio18,bio18,WorldClim_2.1_GFDL-ESM4_ssp370_10m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of warmest quarter,P of warmest qtr,year,mm per quarter,*mm~qtr^-1*, +bio19,bio19,WorldClim_2.1_GFDL-ESM4_ssp370_10m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of coldest quarter,P of coldest qtr,year,mm per quarter,*mm~qtr^-1*, +precipitation_01,precipitation_01,WorldClim_2.1_GFDL-ESM4_ssp370_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jan,P Jan,january,mm per month,*mm~mo^-1*, +precipitation_02,precipitation_02,WorldClim_2.1_GFDL-ESM4_ssp370_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Feb,P Feb,february,mm per month,*mm~mo^-1*, +precipitation_03,precipitation_03,WorldClim_2.1_GFDL-ESM4_ssp370_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Mar,P Mar,march,mm per month,*mm~mo^-1*, +precipitation_04,precipitation_04,WorldClim_2.1_GFDL-ESM4_ssp370_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Apr,P Apr,april,mm per month,*mm~mo^-1*, +precipitation_05,precipitation_05,WorldClim_2.1_GFDL-ESM4_ssp370_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation May,P May,may,mm per month,*mm~mo^-1*, +precipitation_06,precipitation_06,WorldClim_2.1_GFDL-ESM4_ssp370_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jun,P Jun,june,mm per month,*mm~mo^-1*, +precipitation_07,precipitation_07,WorldClim_2.1_GFDL-ESM4_ssp370_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jul,P Jul,july,mm per month,*mm~mo^-1*, +precipitation_08,precipitation_08,WorldClim_2.1_GFDL-ESM4_ssp370_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Aug,P Aug,august,mm per month,*mm~mo^-1*, +precipitation_09,precipitation_09,WorldClim_2.1_GFDL-ESM4_ssp370_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Sep,P Sep,september,mm per month,*mm~mo^-1*, +precipitation_10,precipitation_10,WorldClim_2.1_GFDL-ESM4_ssp370_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Oct,P Oct,october,mm per month,*mm~mo^-1*, +precipitation_11,precipitation_11,WorldClim_2.1_GFDL-ESM4_ssp370_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Nov,P Nov,november,mm per month,*mm~mo^-1*, +precipitation_12,precipitation_12,WorldClim_2.1_GFDL-ESM4_ssp370_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Dec,P Dec,december,mm per month,*mm~mo^-1*, +temperature_min_01,temperature_min_01,WorldClim_2.1_GFDL-ESM4_ssp370_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jan,min T Jan,january,degrees Celsius,*degree*C*, +temperature_min_02,temperature_min_02,WorldClim_2.1_GFDL-ESM4_ssp370_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Feb,min T Feb,february,degrees Celsius,*degree*C*, +temperature_min_03,temperature_min_03,WorldClim_2.1_GFDL-ESM4_ssp370_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Mar,min T Mar,march,degrees Celsius,*degree*C*, +temperature_min_04,temperature_min_04,WorldClim_2.1_GFDL-ESM4_ssp370_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Apr,min T Apr,april,degrees Celsius,*degree*C*, +temperature_min_05,temperature_min_05,WorldClim_2.1_GFDL-ESM4_ssp370_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature May,min T May,may,degrees Celsius,*degree*C*, +temperature_min_06,temperature_min_06,WorldClim_2.1_GFDL-ESM4_ssp370_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jun,min T Jun,june,degrees Celsius,*degree*C*, +temperature_min_07,temperature_min_07,WorldClim_2.1_GFDL-ESM4_ssp370_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jul,min T Jul,july,degrees Celsius,*degree*C*, +temperature_min_08,temperature_min_08,WorldClim_2.1_GFDL-ESM4_ssp370_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Aug,min T Aug,august,degrees Celsius,*degree*C*, +temperature_min_09,temperature_min_09,WorldClim_2.1_GFDL-ESM4_ssp370_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Sep,min T Sep,september,degrees Celsius,*degree*C*, +temperature_min_10,temperature_min_10,WorldClim_2.1_GFDL-ESM4_ssp370_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Oct,min T Oct,october,degrees Celsius,*degree*C*, +temperature_min_11,temperature_min_11,WorldClim_2.1_GFDL-ESM4_ssp370_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Nov,min T Nov,november,degrees Celsius,*degree*C*, +temperature_min_12,temperature_min_12,WorldClim_2.1_GFDL-ESM4_ssp370_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Dec,min T Dec,december,degrees Celsius,*degree*C*, +temperature_max_01,temperature_max_01,WorldClim_2.1_GFDL-ESM4_ssp370_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jan,max T Jan,january,degrees Celsius,*degree*C*, +temperature_max_02,temperature_max_02,WorldClim_2.1_GFDL-ESM4_ssp370_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Feb,max T Feb,february,degrees Celsius,*degree*C*, +temperature_max_03,temperature_max_03,WorldClim_2.1_GFDL-ESM4_ssp370_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Mar,max T Mar,march,degrees Celsius,*degree*C*, +temperature_max_04,temperature_max_04,WorldClim_2.1_GFDL-ESM4_ssp370_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Apr,max T Apr,april,degrees Celsius,*degree*C*, +temperature_max_05,temperature_max_05,WorldClim_2.1_GFDL-ESM4_ssp370_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature May,max T May,may,degrees Celsius,*degree*C*, +temperature_max_06,temperature_max_06,WorldClim_2.1_GFDL-ESM4_ssp370_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jun,max T Jun,june,degrees Celsius,*degree*C*, +temperature_max_07,temperature_max_07,WorldClim_2.1_GFDL-ESM4_ssp370_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jul,max T Jul,july,degrees Celsius,*degree*C*, +temperature_max_08,temperature_max_08,WorldClim_2.1_GFDL-ESM4_ssp370_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Aug,max T Aug,august,degrees Celsius,*degree*C*, +temperature_max_09,temperature_max_09,WorldClim_2.1_GFDL-ESM4_ssp370_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Sep,max T Sep,september,degrees Celsius,*degree*C*, +temperature_max_10,temperature_max_10,WorldClim_2.1_GFDL-ESM4_ssp370_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Oct,max T Oct,october,degrees Celsius,*degree*C*, +temperature_max_11,temperature_max_11,WorldClim_2.1_GFDL-ESM4_ssp370_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Nov,max T Nov,november,degrees Celsius,*degree*C*, +temperature_max_12,temperature_max_12,WorldClim_2.1_GFDL-ESM4_ssp370_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Dec,max T Dec,december,degrees Celsius,*degree*C*, +bio01,bio01,WorldClim_2.1_GFDL-ESM4_ssp370_5m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual mean temperature,ann. mean T,year,degrees Celsius,*degree*C*, +bio02,bio02,WorldClim_2.1_GFDL-ESM4_ssp370_5m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean diurnal range,diurn. range,year,degrees Celsius,*degree*C*, +bio03,bio03,WorldClim_2.1_GFDL-ESM4_ssp370_5m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,isothermality,isothermality,year,,, +bio04,bio04,WorldClim_2.1_GFDL-ESM4_ssp370_5m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature seasonality,T season.,year,degrees Celsius,*degree*C*, +bio05,bio05,WorldClim_2.1_GFDL-ESM4_ssp370_5m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature of warmest month,max. T of warmest mo.,year,degrees Celsius,*degree*C*, +bio06,bio06,WorldClim_2.1_GFDL-ESM4_ssp370_5m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature of coldest month,min. T of coldest mo.,year,degrees Celsius,*degree*C*, +bio07,bio07,WorldClim_2.1_GFDL-ESM4_ssp370_5m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature annual range (bio05-bio06),T ann. Range,year,degrees Celsius,*degree*C*, +bio08,bio08,WorldClim_2.1_GFDL-ESM4_ssp370_5m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of wettest quarter,mean T of wettest qtr,year,degrees Celsius,*degree*C*, +bio09,bio09,WorldClim_2.1_GFDL-ESM4_ssp370_5m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of driest quarter,mean T of driest qtr,year,degrees Celsius,*degree*C*, +bio10,bio10,WorldClim_2.1_GFDL-ESM4_ssp370_5m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of warmest quarter,mean T of warmest qtr,year,degrees Celsius,*degree*C*, +bio11,bio11,WorldClim_2.1_GFDL-ESM4_ssp370_5m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of coldest quarter,mean T of coldest qtr,year,degrees Celsius,*degree*C*, +bio12,bio12,WorldClim_2.1_GFDL-ESM4_ssp370_5m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual precipitation,ann. P,year,mm per year,*mm~yr^-1*, +bio13,bio13,WorldClim_2.1_GFDL-ESM4_ssp370_5m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest month,P of wettest mo.,year,mm per month,*mm~mo^-1*, +bio14,bio14,WorldClim_2.1_GFDL-ESM4_ssp370_5m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest month,P of driest mo.,year,mm per month,*mm~mo^-1*, +bio15,bio15,WorldClim_2.1_GFDL-ESM4_ssp370_5m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation seasonality (coeff var),P season.,year,,, +bio16,bio16,WorldClim_2.1_GFDL-ESM4_ssp370_5m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest quarter,P of wettest qtr,year,mm per quarter,*mm~qtr^-1*, +bio17,bio17,WorldClim_2.1_GFDL-ESM4_ssp370_5m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest quarter,P of driest qtr,year,mm per quarter,*mm~qtr^-1*, +bio18,bio18,WorldClim_2.1_GFDL-ESM4_ssp370_5m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of warmest quarter,P of warmest qtr,year,mm per quarter,*mm~qtr^-1*, +bio19,bio19,WorldClim_2.1_GFDL-ESM4_ssp370_5m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of coldest quarter,P of coldest qtr,year,mm per quarter,*mm~qtr^-1*, +precipitation_01,precipitation_01,WorldClim_2.1_GFDL-ESM4_ssp370_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jan,P Jan,january,mm per month,*mm~mo^-1*, +precipitation_02,precipitation_02,WorldClim_2.1_GFDL-ESM4_ssp370_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Feb,P Feb,february,mm per month,*mm~mo^-1*, +precipitation_03,precipitation_03,WorldClim_2.1_GFDL-ESM4_ssp370_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Mar,P Mar,march,mm per month,*mm~mo^-1*, +precipitation_04,precipitation_04,WorldClim_2.1_GFDL-ESM4_ssp370_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Apr,P Apr,april,mm per month,*mm~mo^-1*, +precipitation_05,precipitation_05,WorldClim_2.1_GFDL-ESM4_ssp370_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation May,P May,may,mm per month,*mm~mo^-1*, +precipitation_06,precipitation_06,WorldClim_2.1_GFDL-ESM4_ssp370_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jun,P Jun,june,mm per month,*mm~mo^-1*, +precipitation_07,precipitation_07,WorldClim_2.1_GFDL-ESM4_ssp370_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jul,P Jul,july,mm per month,*mm~mo^-1*, +precipitation_08,precipitation_08,WorldClim_2.1_GFDL-ESM4_ssp370_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Aug,P Aug,august,mm per month,*mm~mo^-1*, +precipitation_09,precipitation_09,WorldClim_2.1_GFDL-ESM4_ssp370_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Sep,P Sep,september,mm per month,*mm~mo^-1*, +precipitation_10,precipitation_10,WorldClim_2.1_GFDL-ESM4_ssp370_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Oct,P Oct,october,mm per month,*mm~mo^-1*, +precipitation_11,precipitation_11,WorldClim_2.1_GFDL-ESM4_ssp370_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Nov,P Nov,november,mm per month,*mm~mo^-1*, +precipitation_12,precipitation_12,WorldClim_2.1_GFDL-ESM4_ssp370_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Dec,P Dec,december,mm per month,*mm~mo^-1*, +temperature_min_01,temperature_min_01,WorldClim_2.1_GFDL-ESM4_ssp370_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jan,min T Jan,january,degrees Celsius,*degree*C*, +temperature_min_02,temperature_min_02,WorldClim_2.1_GFDL-ESM4_ssp370_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Feb,min T Feb,february,degrees Celsius,*degree*C*, +temperature_min_03,temperature_min_03,WorldClim_2.1_GFDL-ESM4_ssp370_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Mar,min T Mar,march,degrees Celsius,*degree*C*, +temperature_min_04,temperature_min_04,WorldClim_2.1_GFDL-ESM4_ssp370_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Apr,min T Apr,april,degrees Celsius,*degree*C*, +temperature_min_05,temperature_min_05,WorldClim_2.1_GFDL-ESM4_ssp370_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature May,min T May,may,degrees Celsius,*degree*C*, +temperature_min_06,temperature_min_06,WorldClim_2.1_GFDL-ESM4_ssp370_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jun,min T Jun,june,degrees Celsius,*degree*C*, +temperature_min_07,temperature_min_07,WorldClim_2.1_GFDL-ESM4_ssp370_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jul,min T Jul,july,degrees Celsius,*degree*C*, +temperature_min_08,temperature_min_08,WorldClim_2.1_GFDL-ESM4_ssp370_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Aug,min T Aug,august,degrees Celsius,*degree*C*, +temperature_min_09,temperature_min_09,WorldClim_2.1_GFDL-ESM4_ssp370_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Sep,min T Sep,september,degrees Celsius,*degree*C*, +temperature_min_10,temperature_min_10,WorldClim_2.1_GFDL-ESM4_ssp370_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Oct,min T Oct,october,degrees Celsius,*degree*C*, +temperature_min_11,temperature_min_11,WorldClim_2.1_GFDL-ESM4_ssp370_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Nov,min T Nov,november,degrees Celsius,*degree*C*, +temperature_min_12,temperature_min_12,WorldClim_2.1_GFDL-ESM4_ssp370_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Dec,min T Dec,december,degrees Celsius,*degree*C*, +temperature_max_01,temperature_max_01,WorldClim_2.1_GFDL-ESM4_ssp370_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jan,max T Jan,january,degrees Celsius,*degree*C*, +temperature_max_02,temperature_max_02,WorldClim_2.1_GFDL-ESM4_ssp370_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Feb,max T Feb,february,degrees Celsius,*degree*C*, +temperature_max_03,temperature_max_03,WorldClim_2.1_GFDL-ESM4_ssp370_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Mar,max T Mar,march,degrees Celsius,*degree*C*, +temperature_max_04,temperature_max_04,WorldClim_2.1_GFDL-ESM4_ssp370_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Apr,max T Apr,april,degrees Celsius,*degree*C*, +temperature_max_05,temperature_max_05,WorldClim_2.1_GFDL-ESM4_ssp370_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature May,max T May,may,degrees Celsius,*degree*C*, +temperature_max_06,temperature_max_06,WorldClim_2.1_GFDL-ESM4_ssp370_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jun,max T Jun,june,degrees Celsius,*degree*C*, +temperature_max_07,temperature_max_07,WorldClim_2.1_GFDL-ESM4_ssp370_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jul,max T Jul,july,degrees Celsius,*degree*C*, +temperature_max_08,temperature_max_08,WorldClim_2.1_GFDL-ESM4_ssp370_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Aug,max T Aug,august,degrees Celsius,*degree*C*, +temperature_max_09,temperature_max_09,WorldClim_2.1_GFDL-ESM4_ssp370_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Sep,max T Sep,september,degrees Celsius,*degree*C*, +temperature_max_10,temperature_max_10,WorldClim_2.1_GFDL-ESM4_ssp370_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Oct,max T Oct,october,degrees Celsius,*degree*C*, +temperature_max_11,temperature_max_11,WorldClim_2.1_GFDL-ESM4_ssp370_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Nov,max T Nov,november,degrees Celsius,*degree*C*, +temperature_max_12,temperature_max_12,WorldClim_2.1_GFDL-ESM4_ssp370_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Dec,max T Dec,december,degrees Celsius,*degree*C*, +bio01,bio01,WorldClim_2.1_GFDL-ESM4_ssp585_10m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual mean temperature,ann. mean T,year,degrees Celsius,*degree*C*, +bio02,bio02,WorldClim_2.1_GFDL-ESM4_ssp585_10m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean diurnal range,diurn. range,year,degrees Celsius,*degree*C*, +bio03,bio03,WorldClim_2.1_GFDL-ESM4_ssp585_10m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,isothermality,isothermality,year,,, +bio04,bio04,WorldClim_2.1_GFDL-ESM4_ssp585_10m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature seasonality,T season.,year,degrees Celsius,*degree*C*, +bio05,bio05,WorldClim_2.1_GFDL-ESM4_ssp585_10m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature of warmest month,max. T of warmest mo.,year,degrees Celsius,*degree*C*, +bio06,bio06,WorldClim_2.1_GFDL-ESM4_ssp585_10m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature of coldest month,min. T of coldest mo.,year,degrees Celsius,*degree*C*, +bio07,bio07,WorldClim_2.1_GFDL-ESM4_ssp585_10m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature annual range (bio05-bio06),T ann. Range,year,degrees Celsius,*degree*C*, +bio08,bio08,WorldClim_2.1_GFDL-ESM4_ssp585_10m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of wettest quarter,mean T of wettest qtr,year,degrees Celsius,*degree*C*, +bio09,bio09,WorldClim_2.1_GFDL-ESM4_ssp585_10m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of driest quarter,mean T of driest qtr,year,degrees Celsius,*degree*C*, +bio10,bio10,WorldClim_2.1_GFDL-ESM4_ssp585_10m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of warmest quarter,mean T of warmest qtr,year,degrees Celsius,*degree*C*, +bio11,bio11,WorldClim_2.1_GFDL-ESM4_ssp585_10m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of coldest quarter,mean T of coldest qtr,year,degrees Celsius,*degree*C*, +bio12,bio12,WorldClim_2.1_GFDL-ESM4_ssp585_10m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual precipitation,ann. P,year,mm per year,*mm~yr^-1*, +bio13,bio13,WorldClim_2.1_GFDL-ESM4_ssp585_10m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest month,P of wettest mo.,year,mm per month,*mm~mo^-1*, +bio14,bio14,WorldClim_2.1_GFDL-ESM4_ssp585_10m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest month,P of driest mo.,year,mm per month,*mm~mo^-1*, +bio15,bio15,WorldClim_2.1_GFDL-ESM4_ssp585_10m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation seasonality (coeff var),P season.,year,,, +bio16,bio16,WorldClim_2.1_GFDL-ESM4_ssp585_10m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest quarter,P of wettest qtr,year,mm per quarter,*mm~qtr^-1*, +bio17,bio17,WorldClim_2.1_GFDL-ESM4_ssp585_10m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest quarter,P of driest qtr,year,mm per quarter,*mm~qtr^-1*, +bio18,bio18,WorldClim_2.1_GFDL-ESM4_ssp585_10m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of warmest quarter,P of warmest qtr,year,mm per quarter,*mm~qtr^-1*, +bio19,bio19,WorldClim_2.1_GFDL-ESM4_ssp585_10m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of coldest quarter,P of coldest qtr,year,mm per quarter,*mm~qtr^-1*, +precipitation_01,precipitation_01,WorldClim_2.1_GFDL-ESM4_ssp585_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jan,P Jan,january,mm per month,*mm~mo^-1*, +precipitation_02,precipitation_02,WorldClim_2.1_GFDL-ESM4_ssp585_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Feb,P Feb,february,mm per month,*mm~mo^-1*, +precipitation_03,precipitation_03,WorldClim_2.1_GFDL-ESM4_ssp585_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Mar,P Mar,march,mm per month,*mm~mo^-1*, +precipitation_04,precipitation_04,WorldClim_2.1_GFDL-ESM4_ssp585_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Apr,P Apr,april,mm per month,*mm~mo^-1*, +precipitation_05,precipitation_05,WorldClim_2.1_GFDL-ESM4_ssp585_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation May,P May,may,mm per month,*mm~mo^-1*, +precipitation_06,precipitation_06,WorldClim_2.1_GFDL-ESM4_ssp585_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jun,P Jun,june,mm per month,*mm~mo^-1*, +precipitation_07,precipitation_07,WorldClim_2.1_GFDL-ESM4_ssp585_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jul,P Jul,july,mm per month,*mm~mo^-1*, +precipitation_08,precipitation_08,WorldClim_2.1_GFDL-ESM4_ssp585_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Aug,P Aug,august,mm per month,*mm~mo^-1*, +precipitation_09,precipitation_09,WorldClim_2.1_GFDL-ESM4_ssp585_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Sep,P Sep,september,mm per month,*mm~mo^-1*, +precipitation_10,precipitation_10,WorldClim_2.1_GFDL-ESM4_ssp585_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Oct,P Oct,october,mm per month,*mm~mo^-1*, +precipitation_11,precipitation_11,WorldClim_2.1_GFDL-ESM4_ssp585_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Nov,P Nov,november,mm per month,*mm~mo^-1*, +precipitation_12,precipitation_12,WorldClim_2.1_GFDL-ESM4_ssp585_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Dec,P Dec,december,mm per month,*mm~mo^-1*, +temperature_min_01,temperature_min_01,WorldClim_2.1_GFDL-ESM4_ssp585_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jan,min T Jan,january,degrees Celsius,*degree*C*, +temperature_min_02,temperature_min_02,WorldClim_2.1_GFDL-ESM4_ssp585_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Feb,min T Feb,february,degrees Celsius,*degree*C*, +temperature_min_03,temperature_min_03,WorldClim_2.1_GFDL-ESM4_ssp585_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Mar,min T Mar,march,degrees Celsius,*degree*C*, +temperature_min_04,temperature_min_04,WorldClim_2.1_GFDL-ESM4_ssp585_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Apr,min T Apr,april,degrees Celsius,*degree*C*, +temperature_min_05,temperature_min_05,WorldClim_2.1_GFDL-ESM4_ssp585_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature May,min T May,may,degrees Celsius,*degree*C*, +temperature_min_06,temperature_min_06,WorldClim_2.1_GFDL-ESM4_ssp585_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jun,min T Jun,june,degrees Celsius,*degree*C*, +temperature_min_07,temperature_min_07,WorldClim_2.1_GFDL-ESM4_ssp585_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jul,min T Jul,july,degrees Celsius,*degree*C*, +temperature_min_08,temperature_min_08,WorldClim_2.1_GFDL-ESM4_ssp585_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Aug,min T Aug,august,degrees Celsius,*degree*C*, +temperature_min_09,temperature_min_09,WorldClim_2.1_GFDL-ESM4_ssp585_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Sep,min T Sep,september,degrees Celsius,*degree*C*, +temperature_min_10,temperature_min_10,WorldClim_2.1_GFDL-ESM4_ssp585_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Oct,min T Oct,october,degrees Celsius,*degree*C*, +temperature_min_11,temperature_min_11,WorldClim_2.1_GFDL-ESM4_ssp585_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Nov,min T Nov,november,degrees Celsius,*degree*C*, +temperature_min_12,temperature_min_12,WorldClim_2.1_GFDL-ESM4_ssp585_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Dec,min T Dec,december,degrees Celsius,*degree*C*, +temperature_max_01,temperature_max_01,WorldClim_2.1_GFDL-ESM4_ssp585_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jan,max T Jan,january,degrees Celsius,*degree*C*, +temperature_max_02,temperature_max_02,WorldClim_2.1_GFDL-ESM4_ssp585_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Feb,max T Feb,february,degrees Celsius,*degree*C*, +temperature_max_03,temperature_max_03,WorldClim_2.1_GFDL-ESM4_ssp585_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Mar,max T Mar,march,degrees Celsius,*degree*C*, +temperature_max_04,temperature_max_04,WorldClim_2.1_GFDL-ESM4_ssp585_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Apr,max T Apr,april,degrees Celsius,*degree*C*, +temperature_max_05,temperature_max_05,WorldClim_2.1_GFDL-ESM4_ssp585_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature May,max T May,may,degrees Celsius,*degree*C*, +temperature_max_06,temperature_max_06,WorldClim_2.1_GFDL-ESM4_ssp585_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jun,max T Jun,june,degrees Celsius,*degree*C*, +temperature_max_07,temperature_max_07,WorldClim_2.1_GFDL-ESM4_ssp585_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jul,max T Jul,july,degrees Celsius,*degree*C*, +temperature_max_08,temperature_max_08,WorldClim_2.1_GFDL-ESM4_ssp585_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Aug,max T Aug,august,degrees Celsius,*degree*C*, +temperature_max_09,temperature_max_09,WorldClim_2.1_GFDL-ESM4_ssp585_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Sep,max T Sep,september,degrees Celsius,*degree*C*, +temperature_max_10,temperature_max_10,WorldClim_2.1_GFDL-ESM4_ssp585_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Oct,max T Oct,october,degrees Celsius,*degree*C*, +temperature_max_11,temperature_max_11,WorldClim_2.1_GFDL-ESM4_ssp585_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Nov,max T Nov,november,degrees Celsius,*degree*C*, +temperature_max_12,temperature_max_12,WorldClim_2.1_GFDL-ESM4_ssp585_10m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Dec,max T Dec,december,degrees Celsius,*degree*C*, +bio01,bio01,WorldClim_2.1_GFDL-ESM4_ssp585_5m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual mean temperature,ann. mean T,year,degrees Celsius,*degree*C*, +bio02,bio02,WorldClim_2.1_GFDL-ESM4_ssp585_5m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean diurnal range,diurn. range,year,degrees Celsius,*degree*C*, +bio03,bio03,WorldClim_2.1_GFDL-ESM4_ssp585_5m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,isothermality,isothermality,year,,, +bio04,bio04,WorldClim_2.1_GFDL-ESM4_ssp585_5m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature seasonality,T season.,year,degrees Celsius,*degree*C*, +bio05,bio05,WorldClim_2.1_GFDL-ESM4_ssp585_5m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature of warmest month,max. T of warmest mo.,year,degrees Celsius,*degree*C*, +bio06,bio06,WorldClim_2.1_GFDL-ESM4_ssp585_5m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature of coldest month,min. T of coldest mo.,year,degrees Celsius,*degree*C*, +bio07,bio07,WorldClim_2.1_GFDL-ESM4_ssp585_5m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature annual range (bio05-bio06),T ann. Range,year,degrees Celsius,*degree*C*, +bio08,bio08,WorldClim_2.1_GFDL-ESM4_ssp585_5m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of wettest quarter,mean T of wettest qtr,year,degrees Celsius,*degree*C*, +bio09,bio09,WorldClim_2.1_GFDL-ESM4_ssp585_5m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of driest quarter,mean T of driest qtr,year,degrees Celsius,*degree*C*, +bio10,bio10,WorldClim_2.1_GFDL-ESM4_ssp585_5m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of warmest quarter,mean T of warmest qtr,year,degrees Celsius,*degree*C*, +bio11,bio11,WorldClim_2.1_GFDL-ESM4_ssp585_5m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of coldest quarter,mean T of coldest qtr,year,degrees Celsius,*degree*C*, +bio12,bio12,WorldClim_2.1_GFDL-ESM4_ssp585_5m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual precipitation,ann. P,year,mm per year,*mm~yr^-1*, +bio13,bio13,WorldClim_2.1_GFDL-ESM4_ssp585_5m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest month,P of wettest mo.,year,mm per month,*mm~mo^-1*, +bio14,bio14,WorldClim_2.1_GFDL-ESM4_ssp585_5m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest month,P of driest mo.,year,mm per month,*mm~mo^-1*, +bio15,bio15,WorldClim_2.1_GFDL-ESM4_ssp585_5m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation seasonality (coeff var),P season.,year,,, +bio16,bio16,WorldClim_2.1_GFDL-ESM4_ssp585_5m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest quarter,P of wettest qtr,year,mm per quarter,*mm~qtr^-1*, +bio17,bio17,WorldClim_2.1_GFDL-ESM4_ssp585_5m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest quarter,P of driest qtr,year,mm per quarter,*mm~qtr^-1*, +bio18,bio18,WorldClim_2.1_GFDL-ESM4_ssp585_5m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of warmest quarter,P of warmest qtr,year,mm per quarter,*mm~qtr^-1*, +bio19,bio19,WorldClim_2.1_GFDL-ESM4_ssp585_5m,FALSE,WorldClim_2.1_GFDL-ESM4_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of coldest quarter,P of coldest qtr,year,mm per quarter,*mm~qtr^-1*, +precipitation_01,precipitation_01,WorldClim_2.1_GFDL-ESM4_ssp585_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jan,P Jan,january,mm per month,*mm~mo^-1*, +precipitation_02,precipitation_02,WorldClim_2.1_GFDL-ESM4_ssp585_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Feb,P Feb,february,mm per month,*mm~mo^-1*, +precipitation_03,precipitation_03,WorldClim_2.1_GFDL-ESM4_ssp585_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Mar,P Mar,march,mm per month,*mm~mo^-1*, +precipitation_04,precipitation_04,WorldClim_2.1_GFDL-ESM4_ssp585_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Apr,P Apr,april,mm per month,*mm~mo^-1*, +precipitation_05,precipitation_05,WorldClim_2.1_GFDL-ESM4_ssp585_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation May,P May,may,mm per month,*mm~mo^-1*, +precipitation_06,precipitation_06,WorldClim_2.1_GFDL-ESM4_ssp585_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jun,P Jun,june,mm per month,*mm~mo^-1*, +precipitation_07,precipitation_07,WorldClim_2.1_GFDL-ESM4_ssp585_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jul,P Jul,july,mm per month,*mm~mo^-1*, +precipitation_08,precipitation_08,WorldClim_2.1_GFDL-ESM4_ssp585_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Aug,P Aug,august,mm per month,*mm~mo^-1*, +precipitation_09,precipitation_09,WorldClim_2.1_GFDL-ESM4_ssp585_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Sep,P Sep,september,mm per month,*mm~mo^-1*, +precipitation_10,precipitation_10,WorldClim_2.1_GFDL-ESM4_ssp585_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Oct,P Oct,october,mm per month,*mm~mo^-1*, +precipitation_11,precipitation_11,WorldClim_2.1_GFDL-ESM4_ssp585_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Nov,P Nov,november,mm per month,*mm~mo^-1*, +precipitation_12,precipitation_12,WorldClim_2.1_GFDL-ESM4_ssp585_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Dec,P Dec,december,mm per month,*mm~mo^-1*, +temperature_min_01,temperature_min_01,WorldClim_2.1_GFDL-ESM4_ssp585_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jan,min T Jan,january,degrees Celsius,*degree*C*, +temperature_min_02,temperature_min_02,WorldClim_2.1_GFDL-ESM4_ssp585_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Feb,min T Feb,february,degrees Celsius,*degree*C*, +temperature_min_03,temperature_min_03,WorldClim_2.1_GFDL-ESM4_ssp585_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Mar,min T Mar,march,degrees Celsius,*degree*C*, +temperature_min_04,temperature_min_04,WorldClim_2.1_GFDL-ESM4_ssp585_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Apr,min T Apr,april,degrees Celsius,*degree*C*, +temperature_min_05,temperature_min_05,WorldClim_2.1_GFDL-ESM4_ssp585_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature May,min T May,may,degrees Celsius,*degree*C*, +temperature_min_06,temperature_min_06,WorldClim_2.1_GFDL-ESM4_ssp585_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jun,min T Jun,june,degrees Celsius,*degree*C*, +temperature_min_07,temperature_min_07,WorldClim_2.1_GFDL-ESM4_ssp585_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jul,min T Jul,july,degrees Celsius,*degree*C*, +temperature_min_08,temperature_min_08,WorldClim_2.1_GFDL-ESM4_ssp585_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Aug,min T Aug,august,degrees Celsius,*degree*C*, +temperature_min_09,temperature_min_09,WorldClim_2.1_GFDL-ESM4_ssp585_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Sep,min T Sep,september,degrees Celsius,*degree*C*, +temperature_min_10,temperature_min_10,WorldClim_2.1_GFDL-ESM4_ssp585_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Oct,min T Oct,october,degrees Celsius,*degree*C*, +temperature_min_11,temperature_min_11,WorldClim_2.1_GFDL-ESM4_ssp585_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Nov,min T Nov,november,degrees Celsius,*degree*C*, +temperature_min_12,temperature_min_12,WorldClim_2.1_GFDL-ESM4_ssp585_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Dec,min T Dec,december,degrees Celsius,*degree*C*, +temperature_max_01,temperature_max_01,WorldClim_2.1_GFDL-ESM4_ssp585_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jan,max T Jan,january,degrees Celsius,*degree*C*, +temperature_max_02,temperature_max_02,WorldClim_2.1_GFDL-ESM4_ssp585_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Feb,max T Feb,february,degrees Celsius,*degree*C*, +temperature_max_03,temperature_max_03,WorldClim_2.1_GFDL-ESM4_ssp585_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Mar,max T Mar,march,degrees Celsius,*degree*C*, +temperature_max_04,temperature_max_04,WorldClim_2.1_GFDL-ESM4_ssp585_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Apr,max T Apr,april,degrees Celsius,*degree*C*, +temperature_max_05,temperature_max_05,WorldClim_2.1_GFDL-ESM4_ssp585_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature May,max T May,may,degrees Celsius,*degree*C*, +temperature_max_06,temperature_max_06,WorldClim_2.1_GFDL-ESM4_ssp585_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jun,max T Jun,june,degrees Celsius,*degree*C*, +temperature_max_07,temperature_max_07,WorldClim_2.1_GFDL-ESM4_ssp585_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jul,max T Jul,july,degrees Celsius,*degree*C*, +temperature_max_08,temperature_max_08,WorldClim_2.1_GFDL-ESM4_ssp585_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Aug,max T Aug,august,degrees Celsius,*degree*C*, +temperature_max_09,temperature_max_09,WorldClim_2.1_GFDL-ESM4_ssp585_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Sep,max T Sep,september,degrees Celsius,*degree*C*, +temperature_max_10,temperature_max_10,WorldClim_2.1_GFDL-ESM4_ssp585_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Oct,max T Oct,october,degrees Celsius,*degree*C*, +temperature_max_11,temperature_max_11,WorldClim_2.1_GFDL-ESM4_ssp585_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Nov,max T Nov,november,degrees Celsius,*degree*C*, +temperature_max_12,temperature_max_12,WorldClim_2.1_GFDL-ESM4_ssp585_5m,TRUE,WorldClim_2.1_GFDL-ESM4_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Dec,max T Dec,december,degrees Celsius,*degree*C*, +bio01,bio01,WorldClim_2.1_GISS-E2-1-G_ssp126_10m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual mean temperature,ann. mean T,year,degrees Celsius,*degree*C*, +bio02,bio02,WorldClim_2.1_GISS-E2-1-G_ssp126_10m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean diurnal range,diurn. range,year,degrees Celsius,*degree*C*, +bio03,bio03,WorldClim_2.1_GISS-E2-1-G_ssp126_10m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,isothermality,isothermality,year,,, +bio04,bio04,WorldClim_2.1_GISS-E2-1-G_ssp126_10m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature seasonality,T season.,year,degrees Celsius,*degree*C*, +bio05,bio05,WorldClim_2.1_GISS-E2-1-G_ssp126_10m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature of warmest month,max. T of warmest mo.,year,degrees Celsius,*degree*C*, +bio06,bio06,WorldClim_2.1_GISS-E2-1-G_ssp126_10m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature of coldest month,min. T of coldest mo.,year,degrees Celsius,*degree*C*, +bio07,bio07,WorldClim_2.1_GISS-E2-1-G_ssp126_10m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature annual range (bio05-bio06),T ann. Range,year,degrees Celsius,*degree*C*, +bio08,bio08,WorldClim_2.1_GISS-E2-1-G_ssp126_10m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of wettest quarter,mean T of wettest qtr,year,degrees Celsius,*degree*C*, +bio09,bio09,WorldClim_2.1_GISS-E2-1-G_ssp126_10m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of driest quarter,mean T of driest qtr,year,degrees Celsius,*degree*C*, +bio10,bio10,WorldClim_2.1_GISS-E2-1-G_ssp126_10m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of warmest quarter,mean T of warmest qtr,year,degrees Celsius,*degree*C*, +bio11,bio11,WorldClim_2.1_GISS-E2-1-G_ssp126_10m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of coldest quarter,mean T of coldest qtr,year,degrees Celsius,*degree*C*, +bio12,bio12,WorldClim_2.1_GISS-E2-1-G_ssp126_10m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual precipitation,ann. P,year,mm per year,*mm~yr^-1*, +bio13,bio13,WorldClim_2.1_GISS-E2-1-G_ssp126_10m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest month,P of wettest mo.,year,mm per month,*mm~mo^-1*, +bio14,bio14,WorldClim_2.1_GISS-E2-1-G_ssp126_10m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest month,P of driest mo.,year,mm per month,*mm~mo^-1*, +bio15,bio15,WorldClim_2.1_GISS-E2-1-G_ssp126_10m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation seasonality (coeff var),P season.,year,,, +bio16,bio16,WorldClim_2.1_GISS-E2-1-G_ssp126_10m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest quarter,P of wettest qtr,year,mm per quarter,*mm~qtr^-1*, +bio17,bio17,WorldClim_2.1_GISS-E2-1-G_ssp126_10m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest quarter,P of driest qtr,year,mm per quarter,*mm~qtr^-1*, +bio18,bio18,WorldClim_2.1_GISS-E2-1-G_ssp126_10m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of warmest quarter,P of warmest qtr,year,mm per quarter,*mm~qtr^-1*, +bio19,bio19,WorldClim_2.1_GISS-E2-1-G_ssp126_10m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of coldest quarter,P of coldest qtr,year,mm per quarter,*mm~qtr^-1*, +precipitation_01,precipitation_01,WorldClim_2.1_GISS-E2-1-G_ssp126_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jan,P Jan,january,mm per month,*mm~mo^-1*, +precipitation_02,precipitation_02,WorldClim_2.1_GISS-E2-1-G_ssp126_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Feb,P Feb,february,mm per month,*mm~mo^-1*, +precipitation_03,precipitation_03,WorldClim_2.1_GISS-E2-1-G_ssp126_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Mar,P Mar,march,mm per month,*mm~mo^-1*, +precipitation_04,precipitation_04,WorldClim_2.1_GISS-E2-1-G_ssp126_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Apr,P Apr,april,mm per month,*mm~mo^-1*, +precipitation_05,precipitation_05,WorldClim_2.1_GISS-E2-1-G_ssp126_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation May,P May,may,mm per month,*mm~mo^-1*, +precipitation_06,precipitation_06,WorldClim_2.1_GISS-E2-1-G_ssp126_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jun,P Jun,june,mm per month,*mm~mo^-1*, +precipitation_07,precipitation_07,WorldClim_2.1_GISS-E2-1-G_ssp126_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jul,P Jul,july,mm per month,*mm~mo^-1*, +precipitation_08,precipitation_08,WorldClim_2.1_GISS-E2-1-G_ssp126_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Aug,P Aug,august,mm per month,*mm~mo^-1*, +precipitation_09,precipitation_09,WorldClim_2.1_GISS-E2-1-G_ssp126_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Sep,P Sep,september,mm per month,*mm~mo^-1*, +precipitation_10,precipitation_10,WorldClim_2.1_GISS-E2-1-G_ssp126_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Oct,P Oct,october,mm per month,*mm~mo^-1*, +precipitation_11,precipitation_11,WorldClim_2.1_GISS-E2-1-G_ssp126_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Nov,P Nov,november,mm per month,*mm~mo^-1*, +precipitation_12,precipitation_12,WorldClim_2.1_GISS-E2-1-G_ssp126_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Dec,P Dec,december,mm per month,*mm~mo^-1*, +temperature_min_01,temperature_min_01,WorldClim_2.1_GISS-E2-1-G_ssp126_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jan,min T Jan,january,degrees Celsius,*degree*C*, +temperature_min_02,temperature_min_02,WorldClim_2.1_GISS-E2-1-G_ssp126_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Feb,min T Feb,february,degrees Celsius,*degree*C*, +temperature_min_03,temperature_min_03,WorldClim_2.1_GISS-E2-1-G_ssp126_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Mar,min T Mar,march,degrees Celsius,*degree*C*, +temperature_min_04,temperature_min_04,WorldClim_2.1_GISS-E2-1-G_ssp126_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Apr,min T Apr,april,degrees Celsius,*degree*C*, +temperature_min_05,temperature_min_05,WorldClim_2.1_GISS-E2-1-G_ssp126_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature May,min T May,may,degrees Celsius,*degree*C*, +temperature_min_06,temperature_min_06,WorldClim_2.1_GISS-E2-1-G_ssp126_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jun,min T Jun,june,degrees Celsius,*degree*C*, +temperature_min_07,temperature_min_07,WorldClim_2.1_GISS-E2-1-G_ssp126_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jul,min T Jul,july,degrees Celsius,*degree*C*, +temperature_min_08,temperature_min_08,WorldClim_2.1_GISS-E2-1-G_ssp126_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Aug,min T Aug,august,degrees Celsius,*degree*C*, +temperature_min_09,temperature_min_09,WorldClim_2.1_GISS-E2-1-G_ssp126_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Sep,min T Sep,september,degrees Celsius,*degree*C*, +temperature_min_10,temperature_min_10,WorldClim_2.1_GISS-E2-1-G_ssp126_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Oct,min T Oct,october,degrees Celsius,*degree*C*, +temperature_min_11,temperature_min_11,WorldClim_2.1_GISS-E2-1-G_ssp126_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Nov,min T Nov,november,degrees Celsius,*degree*C*, +temperature_min_12,temperature_min_12,WorldClim_2.1_GISS-E2-1-G_ssp126_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Dec,min T Dec,december,degrees Celsius,*degree*C*, +temperature_max_01,temperature_max_01,WorldClim_2.1_GISS-E2-1-G_ssp126_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jan,max T Jan,january,degrees Celsius,*degree*C*, +temperature_max_02,temperature_max_02,WorldClim_2.1_GISS-E2-1-G_ssp126_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Feb,max T Feb,february,degrees Celsius,*degree*C*, +temperature_max_03,temperature_max_03,WorldClim_2.1_GISS-E2-1-G_ssp126_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Mar,max T Mar,march,degrees Celsius,*degree*C*, +temperature_max_04,temperature_max_04,WorldClim_2.1_GISS-E2-1-G_ssp126_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Apr,max T Apr,april,degrees Celsius,*degree*C*, +temperature_max_05,temperature_max_05,WorldClim_2.1_GISS-E2-1-G_ssp126_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature May,max T May,may,degrees Celsius,*degree*C*, +temperature_max_06,temperature_max_06,WorldClim_2.1_GISS-E2-1-G_ssp126_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jun,max T Jun,june,degrees Celsius,*degree*C*, +temperature_max_07,temperature_max_07,WorldClim_2.1_GISS-E2-1-G_ssp126_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jul,max T Jul,july,degrees Celsius,*degree*C*, +temperature_max_08,temperature_max_08,WorldClim_2.1_GISS-E2-1-G_ssp126_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Aug,max T Aug,august,degrees Celsius,*degree*C*, +temperature_max_09,temperature_max_09,WorldClim_2.1_GISS-E2-1-G_ssp126_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Sep,max T Sep,september,degrees Celsius,*degree*C*, +temperature_max_10,temperature_max_10,WorldClim_2.1_GISS-E2-1-G_ssp126_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Oct,max T Oct,october,degrees Celsius,*degree*C*, +temperature_max_11,temperature_max_11,WorldClim_2.1_GISS-E2-1-G_ssp126_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Nov,max T Nov,november,degrees Celsius,*degree*C*, +temperature_max_12,temperature_max_12,WorldClim_2.1_GISS-E2-1-G_ssp126_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Dec,max T Dec,december,degrees Celsius,*degree*C*, +bio01,bio01,WorldClim_2.1_GISS-E2-1-G_ssp126_5m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual mean temperature,ann. mean T,year,degrees Celsius,*degree*C*, +bio02,bio02,WorldClim_2.1_GISS-E2-1-G_ssp126_5m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean diurnal range,diurn. range,year,degrees Celsius,*degree*C*, +bio03,bio03,WorldClim_2.1_GISS-E2-1-G_ssp126_5m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,isothermality,isothermality,year,,, +bio04,bio04,WorldClim_2.1_GISS-E2-1-G_ssp126_5m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature seasonality,T season.,year,degrees Celsius,*degree*C*, +bio05,bio05,WorldClim_2.1_GISS-E2-1-G_ssp126_5m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature of warmest month,max. T of warmest mo.,year,degrees Celsius,*degree*C*, +bio06,bio06,WorldClim_2.1_GISS-E2-1-G_ssp126_5m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature of coldest month,min. T of coldest mo.,year,degrees Celsius,*degree*C*, +bio07,bio07,WorldClim_2.1_GISS-E2-1-G_ssp126_5m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature annual range (bio05-bio06),T ann. Range,year,degrees Celsius,*degree*C*, +bio08,bio08,WorldClim_2.1_GISS-E2-1-G_ssp126_5m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of wettest quarter,mean T of wettest qtr,year,degrees Celsius,*degree*C*, +bio09,bio09,WorldClim_2.1_GISS-E2-1-G_ssp126_5m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of driest quarter,mean T of driest qtr,year,degrees Celsius,*degree*C*, +bio10,bio10,WorldClim_2.1_GISS-E2-1-G_ssp126_5m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of warmest quarter,mean T of warmest qtr,year,degrees Celsius,*degree*C*, +bio11,bio11,WorldClim_2.1_GISS-E2-1-G_ssp126_5m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of coldest quarter,mean T of coldest qtr,year,degrees Celsius,*degree*C*, +bio12,bio12,WorldClim_2.1_GISS-E2-1-G_ssp126_5m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual precipitation,ann. P,year,mm per year,*mm~yr^-1*, +bio13,bio13,WorldClim_2.1_GISS-E2-1-G_ssp126_5m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest month,P of wettest mo.,year,mm per month,*mm~mo^-1*, +bio14,bio14,WorldClim_2.1_GISS-E2-1-G_ssp126_5m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest month,P of driest mo.,year,mm per month,*mm~mo^-1*, +bio15,bio15,WorldClim_2.1_GISS-E2-1-G_ssp126_5m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation seasonality (coeff var),P season.,year,,, +bio16,bio16,WorldClim_2.1_GISS-E2-1-G_ssp126_5m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest quarter,P of wettest qtr,year,mm per quarter,*mm~qtr^-1*, +bio17,bio17,WorldClim_2.1_GISS-E2-1-G_ssp126_5m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest quarter,P of driest qtr,year,mm per quarter,*mm~qtr^-1*, +bio18,bio18,WorldClim_2.1_GISS-E2-1-G_ssp126_5m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of warmest quarter,P of warmest qtr,year,mm per quarter,*mm~qtr^-1*, +bio19,bio19,WorldClim_2.1_GISS-E2-1-G_ssp126_5m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of coldest quarter,P of coldest qtr,year,mm per quarter,*mm~qtr^-1*, +precipitation_01,precipitation_01,WorldClim_2.1_GISS-E2-1-G_ssp126_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jan,P Jan,january,mm per month,*mm~mo^-1*, +precipitation_02,precipitation_02,WorldClim_2.1_GISS-E2-1-G_ssp126_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Feb,P Feb,february,mm per month,*mm~mo^-1*, +precipitation_03,precipitation_03,WorldClim_2.1_GISS-E2-1-G_ssp126_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Mar,P Mar,march,mm per month,*mm~mo^-1*, +precipitation_04,precipitation_04,WorldClim_2.1_GISS-E2-1-G_ssp126_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Apr,P Apr,april,mm per month,*mm~mo^-1*, +precipitation_05,precipitation_05,WorldClim_2.1_GISS-E2-1-G_ssp126_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation May,P May,may,mm per month,*mm~mo^-1*, +precipitation_06,precipitation_06,WorldClim_2.1_GISS-E2-1-G_ssp126_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jun,P Jun,june,mm per month,*mm~mo^-1*, +precipitation_07,precipitation_07,WorldClim_2.1_GISS-E2-1-G_ssp126_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jul,P Jul,july,mm per month,*mm~mo^-1*, +precipitation_08,precipitation_08,WorldClim_2.1_GISS-E2-1-G_ssp126_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Aug,P Aug,august,mm per month,*mm~mo^-1*, +precipitation_09,precipitation_09,WorldClim_2.1_GISS-E2-1-G_ssp126_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Sep,P Sep,september,mm per month,*mm~mo^-1*, +precipitation_10,precipitation_10,WorldClim_2.1_GISS-E2-1-G_ssp126_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Oct,P Oct,october,mm per month,*mm~mo^-1*, +precipitation_11,precipitation_11,WorldClim_2.1_GISS-E2-1-G_ssp126_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Nov,P Nov,november,mm per month,*mm~mo^-1*, +precipitation_12,precipitation_12,WorldClim_2.1_GISS-E2-1-G_ssp126_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Dec,P Dec,december,mm per month,*mm~mo^-1*, +temperature_min_01,temperature_min_01,WorldClim_2.1_GISS-E2-1-G_ssp126_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jan,min T Jan,january,degrees Celsius,*degree*C*, +temperature_min_02,temperature_min_02,WorldClim_2.1_GISS-E2-1-G_ssp126_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Feb,min T Feb,february,degrees Celsius,*degree*C*, +temperature_min_03,temperature_min_03,WorldClim_2.1_GISS-E2-1-G_ssp126_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Mar,min T Mar,march,degrees Celsius,*degree*C*, +temperature_min_04,temperature_min_04,WorldClim_2.1_GISS-E2-1-G_ssp126_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Apr,min T Apr,april,degrees Celsius,*degree*C*, +temperature_min_05,temperature_min_05,WorldClim_2.1_GISS-E2-1-G_ssp126_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature May,min T May,may,degrees Celsius,*degree*C*, +temperature_min_06,temperature_min_06,WorldClim_2.1_GISS-E2-1-G_ssp126_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jun,min T Jun,june,degrees Celsius,*degree*C*, +temperature_min_07,temperature_min_07,WorldClim_2.1_GISS-E2-1-G_ssp126_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jul,min T Jul,july,degrees Celsius,*degree*C*, +temperature_min_08,temperature_min_08,WorldClim_2.1_GISS-E2-1-G_ssp126_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Aug,min T Aug,august,degrees Celsius,*degree*C*, +temperature_min_09,temperature_min_09,WorldClim_2.1_GISS-E2-1-G_ssp126_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Sep,min T Sep,september,degrees Celsius,*degree*C*, +temperature_min_10,temperature_min_10,WorldClim_2.1_GISS-E2-1-G_ssp126_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Oct,min T Oct,october,degrees Celsius,*degree*C*, +temperature_min_11,temperature_min_11,WorldClim_2.1_GISS-E2-1-G_ssp126_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Nov,min T Nov,november,degrees Celsius,*degree*C*, +temperature_min_12,temperature_min_12,WorldClim_2.1_GISS-E2-1-G_ssp126_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Dec,min T Dec,december,degrees Celsius,*degree*C*, +temperature_max_01,temperature_max_01,WorldClim_2.1_GISS-E2-1-G_ssp126_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jan,max T Jan,january,degrees Celsius,*degree*C*, +temperature_max_02,temperature_max_02,WorldClim_2.1_GISS-E2-1-G_ssp126_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Feb,max T Feb,february,degrees Celsius,*degree*C*, +temperature_max_03,temperature_max_03,WorldClim_2.1_GISS-E2-1-G_ssp126_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Mar,max T Mar,march,degrees Celsius,*degree*C*, +temperature_max_04,temperature_max_04,WorldClim_2.1_GISS-E2-1-G_ssp126_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Apr,max T Apr,april,degrees Celsius,*degree*C*, +temperature_max_05,temperature_max_05,WorldClim_2.1_GISS-E2-1-G_ssp126_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature May,max T May,may,degrees Celsius,*degree*C*, +temperature_max_06,temperature_max_06,WorldClim_2.1_GISS-E2-1-G_ssp126_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jun,max T Jun,june,degrees Celsius,*degree*C*, +temperature_max_07,temperature_max_07,WorldClim_2.1_GISS-E2-1-G_ssp126_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jul,max T Jul,july,degrees Celsius,*degree*C*, +temperature_max_08,temperature_max_08,WorldClim_2.1_GISS-E2-1-G_ssp126_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Aug,max T Aug,august,degrees Celsius,*degree*C*, +temperature_max_09,temperature_max_09,WorldClim_2.1_GISS-E2-1-G_ssp126_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Sep,max T Sep,september,degrees Celsius,*degree*C*, +temperature_max_10,temperature_max_10,WorldClim_2.1_GISS-E2-1-G_ssp126_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Oct,max T Oct,october,degrees Celsius,*degree*C*, +temperature_max_11,temperature_max_11,WorldClim_2.1_GISS-E2-1-G_ssp126_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Nov,max T Nov,november,degrees Celsius,*degree*C*, +temperature_max_12,temperature_max_12,WorldClim_2.1_GISS-E2-1-G_ssp126_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Dec,max T Dec,december,degrees Celsius,*degree*C*, +bio01,bio01,WorldClim_2.1_GISS-E2-1-G_ssp245_10m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual mean temperature,ann. mean T,year,degrees Celsius,*degree*C*, +bio02,bio02,WorldClim_2.1_GISS-E2-1-G_ssp245_10m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean diurnal range,diurn. range,year,degrees Celsius,*degree*C*, +bio03,bio03,WorldClim_2.1_GISS-E2-1-G_ssp245_10m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,isothermality,isothermality,year,,, +bio04,bio04,WorldClim_2.1_GISS-E2-1-G_ssp245_10m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature seasonality,T season.,year,degrees Celsius,*degree*C*, +bio05,bio05,WorldClim_2.1_GISS-E2-1-G_ssp245_10m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature of warmest month,max. T of warmest mo.,year,degrees Celsius,*degree*C*, +bio06,bio06,WorldClim_2.1_GISS-E2-1-G_ssp245_10m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature of coldest month,min. T of coldest mo.,year,degrees Celsius,*degree*C*, +bio07,bio07,WorldClim_2.1_GISS-E2-1-G_ssp245_10m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature annual range (bio05-bio06),T ann. Range,year,degrees Celsius,*degree*C*, +bio08,bio08,WorldClim_2.1_GISS-E2-1-G_ssp245_10m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of wettest quarter,mean T of wettest qtr,year,degrees Celsius,*degree*C*, +bio09,bio09,WorldClim_2.1_GISS-E2-1-G_ssp245_10m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of driest quarter,mean T of driest qtr,year,degrees Celsius,*degree*C*, +bio10,bio10,WorldClim_2.1_GISS-E2-1-G_ssp245_10m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of warmest quarter,mean T of warmest qtr,year,degrees Celsius,*degree*C*, +bio11,bio11,WorldClim_2.1_GISS-E2-1-G_ssp245_10m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of coldest quarter,mean T of coldest qtr,year,degrees Celsius,*degree*C*, +bio12,bio12,WorldClim_2.1_GISS-E2-1-G_ssp245_10m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual precipitation,ann. P,year,mm per year,*mm~yr^-1*, +bio13,bio13,WorldClim_2.1_GISS-E2-1-G_ssp245_10m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest month,P of wettest mo.,year,mm per month,*mm~mo^-1*, +bio14,bio14,WorldClim_2.1_GISS-E2-1-G_ssp245_10m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest month,P of driest mo.,year,mm per month,*mm~mo^-1*, +bio15,bio15,WorldClim_2.1_GISS-E2-1-G_ssp245_10m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation seasonality (coeff var),P season.,year,,, +bio16,bio16,WorldClim_2.1_GISS-E2-1-G_ssp245_10m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest quarter,P of wettest qtr,year,mm per quarter,*mm~qtr^-1*, +bio17,bio17,WorldClim_2.1_GISS-E2-1-G_ssp245_10m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest quarter,P of driest qtr,year,mm per quarter,*mm~qtr^-1*, +bio18,bio18,WorldClim_2.1_GISS-E2-1-G_ssp245_10m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of warmest quarter,P of warmest qtr,year,mm per quarter,*mm~qtr^-1*, +bio19,bio19,WorldClim_2.1_GISS-E2-1-G_ssp245_10m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of coldest quarter,P of coldest qtr,year,mm per quarter,*mm~qtr^-1*, +precipitation_01,precipitation_01,WorldClim_2.1_GISS-E2-1-G_ssp245_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jan,P Jan,january,mm per month,*mm~mo^-1*, +precipitation_02,precipitation_02,WorldClim_2.1_GISS-E2-1-G_ssp245_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Feb,P Feb,february,mm per month,*mm~mo^-1*, +precipitation_03,precipitation_03,WorldClim_2.1_GISS-E2-1-G_ssp245_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Mar,P Mar,march,mm per month,*mm~mo^-1*, +precipitation_04,precipitation_04,WorldClim_2.1_GISS-E2-1-G_ssp245_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Apr,P Apr,april,mm per month,*mm~mo^-1*, +precipitation_05,precipitation_05,WorldClim_2.1_GISS-E2-1-G_ssp245_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation May,P May,may,mm per month,*mm~mo^-1*, +precipitation_06,precipitation_06,WorldClim_2.1_GISS-E2-1-G_ssp245_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jun,P Jun,june,mm per month,*mm~mo^-1*, +precipitation_07,precipitation_07,WorldClim_2.1_GISS-E2-1-G_ssp245_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jul,P Jul,july,mm per month,*mm~mo^-1*, +precipitation_08,precipitation_08,WorldClim_2.1_GISS-E2-1-G_ssp245_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Aug,P Aug,august,mm per month,*mm~mo^-1*, +precipitation_09,precipitation_09,WorldClim_2.1_GISS-E2-1-G_ssp245_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Sep,P Sep,september,mm per month,*mm~mo^-1*, +precipitation_10,precipitation_10,WorldClim_2.1_GISS-E2-1-G_ssp245_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Oct,P Oct,october,mm per month,*mm~mo^-1*, +precipitation_11,precipitation_11,WorldClim_2.1_GISS-E2-1-G_ssp245_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Nov,P Nov,november,mm per month,*mm~mo^-1*, +precipitation_12,precipitation_12,WorldClim_2.1_GISS-E2-1-G_ssp245_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Dec,P Dec,december,mm per month,*mm~mo^-1*, +temperature_min_01,temperature_min_01,WorldClim_2.1_GISS-E2-1-G_ssp245_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jan,min T Jan,january,degrees Celsius,*degree*C*, +temperature_min_02,temperature_min_02,WorldClim_2.1_GISS-E2-1-G_ssp245_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Feb,min T Feb,february,degrees Celsius,*degree*C*, +temperature_min_03,temperature_min_03,WorldClim_2.1_GISS-E2-1-G_ssp245_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Mar,min T Mar,march,degrees Celsius,*degree*C*, +temperature_min_04,temperature_min_04,WorldClim_2.1_GISS-E2-1-G_ssp245_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Apr,min T Apr,april,degrees Celsius,*degree*C*, +temperature_min_05,temperature_min_05,WorldClim_2.1_GISS-E2-1-G_ssp245_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature May,min T May,may,degrees Celsius,*degree*C*, +temperature_min_06,temperature_min_06,WorldClim_2.1_GISS-E2-1-G_ssp245_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jun,min T Jun,june,degrees Celsius,*degree*C*, +temperature_min_07,temperature_min_07,WorldClim_2.1_GISS-E2-1-G_ssp245_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jul,min T Jul,july,degrees Celsius,*degree*C*, +temperature_min_08,temperature_min_08,WorldClim_2.1_GISS-E2-1-G_ssp245_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Aug,min T Aug,august,degrees Celsius,*degree*C*, +temperature_min_09,temperature_min_09,WorldClim_2.1_GISS-E2-1-G_ssp245_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Sep,min T Sep,september,degrees Celsius,*degree*C*, +temperature_min_10,temperature_min_10,WorldClim_2.1_GISS-E2-1-G_ssp245_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Oct,min T Oct,october,degrees Celsius,*degree*C*, +temperature_min_11,temperature_min_11,WorldClim_2.1_GISS-E2-1-G_ssp245_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Nov,min T Nov,november,degrees Celsius,*degree*C*, +temperature_min_12,temperature_min_12,WorldClim_2.1_GISS-E2-1-G_ssp245_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Dec,min T Dec,december,degrees Celsius,*degree*C*, +temperature_max_01,temperature_max_01,WorldClim_2.1_GISS-E2-1-G_ssp245_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jan,max T Jan,january,degrees Celsius,*degree*C*, +temperature_max_02,temperature_max_02,WorldClim_2.1_GISS-E2-1-G_ssp245_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Feb,max T Feb,february,degrees Celsius,*degree*C*, +temperature_max_03,temperature_max_03,WorldClim_2.1_GISS-E2-1-G_ssp245_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Mar,max T Mar,march,degrees Celsius,*degree*C*, +temperature_max_04,temperature_max_04,WorldClim_2.1_GISS-E2-1-G_ssp245_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Apr,max T Apr,april,degrees Celsius,*degree*C*, +temperature_max_05,temperature_max_05,WorldClim_2.1_GISS-E2-1-G_ssp245_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature May,max T May,may,degrees Celsius,*degree*C*, +temperature_max_06,temperature_max_06,WorldClim_2.1_GISS-E2-1-G_ssp245_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jun,max T Jun,june,degrees Celsius,*degree*C*, +temperature_max_07,temperature_max_07,WorldClim_2.1_GISS-E2-1-G_ssp245_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jul,max T Jul,july,degrees Celsius,*degree*C*, +temperature_max_08,temperature_max_08,WorldClim_2.1_GISS-E2-1-G_ssp245_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Aug,max T Aug,august,degrees Celsius,*degree*C*, +temperature_max_09,temperature_max_09,WorldClim_2.1_GISS-E2-1-G_ssp245_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Sep,max T Sep,september,degrees Celsius,*degree*C*, +temperature_max_10,temperature_max_10,WorldClim_2.1_GISS-E2-1-G_ssp245_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Oct,max T Oct,october,degrees Celsius,*degree*C*, +temperature_max_11,temperature_max_11,WorldClim_2.1_GISS-E2-1-G_ssp245_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Nov,max T Nov,november,degrees Celsius,*degree*C*, +temperature_max_12,temperature_max_12,WorldClim_2.1_GISS-E2-1-G_ssp245_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Dec,max T Dec,december,degrees Celsius,*degree*C*, +bio01,bio01,WorldClim_2.1_GISS-E2-1-G_ssp245_5m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual mean temperature,ann. mean T,year,degrees Celsius,*degree*C*, +bio02,bio02,WorldClim_2.1_GISS-E2-1-G_ssp245_5m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean diurnal range,diurn. range,year,degrees Celsius,*degree*C*, +bio03,bio03,WorldClim_2.1_GISS-E2-1-G_ssp245_5m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,isothermality,isothermality,year,,, +bio04,bio04,WorldClim_2.1_GISS-E2-1-G_ssp245_5m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature seasonality,T season.,year,degrees Celsius,*degree*C*, +bio05,bio05,WorldClim_2.1_GISS-E2-1-G_ssp245_5m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature of warmest month,max. T of warmest mo.,year,degrees Celsius,*degree*C*, +bio06,bio06,WorldClim_2.1_GISS-E2-1-G_ssp245_5m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature of coldest month,min. T of coldest mo.,year,degrees Celsius,*degree*C*, +bio07,bio07,WorldClim_2.1_GISS-E2-1-G_ssp245_5m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature annual range (bio05-bio06),T ann. Range,year,degrees Celsius,*degree*C*, +bio08,bio08,WorldClim_2.1_GISS-E2-1-G_ssp245_5m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of wettest quarter,mean T of wettest qtr,year,degrees Celsius,*degree*C*, +bio09,bio09,WorldClim_2.1_GISS-E2-1-G_ssp245_5m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of driest quarter,mean T of driest qtr,year,degrees Celsius,*degree*C*, +bio10,bio10,WorldClim_2.1_GISS-E2-1-G_ssp245_5m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of warmest quarter,mean T of warmest qtr,year,degrees Celsius,*degree*C*, +bio11,bio11,WorldClim_2.1_GISS-E2-1-G_ssp245_5m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of coldest quarter,mean T of coldest qtr,year,degrees Celsius,*degree*C*, +bio12,bio12,WorldClim_2.1_GISS-E2-1-G_ssp245_5m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual precipitation,ann. P,year,mm per year,*mm~yr^-1*, +bio13,bio13,WorldClim_2.1_GISS-E2-1-G_ssp245_5m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest month,P of wettest mo.,year,mm per month,*mm~mo^-1*, +bio14,bio14,WorldClim_2.1_GISS-E2-1-G_ssp245_5m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest month,P of driest mo.,year,mm per month,*mm~mo^-1*, +bio15,bio15,WorldClim_2.1_GISS-E2-1-G_ssp245_5m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation seasonality (coeff var),P season.,year,,, +bio16,bio16,WorldClim_2.1_GISS-E2-1-G_ssp245_5m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest quarter,P of wettest qtr,year,mm per quarter,*mm~qtr^-1*, +bio17,bio17,WorldClim_2.1_GISS-E2-1-G_ssp245_5m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest quarter,P of driest qtr,year,mm per quarter,*mm~qtr^-1*, +bio18,bio18,WorldClim_2.1_GISS-E2-1-G_ssp245_5m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of warmest quarter,P of warmest qtr,year,mm per quarter,*mm~qtr^-1*, +bio19,bio19,WorldClim_2.1_GISS-E2-1-G_ssp245_5m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of coldest quarter,P of coldest qtr,year,mm per quarter,*mm~qtr^-1*, +precipitation_01,precipitation_01,WorldClim_2.1_GISS-E2-1-G_ssp245_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jan,P Jan,january,mm per month,*mm~mo^-1*, +precipitation_02,precipitation_02,WorldClim_2.1_GISS-E2-1-G_ssp245_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Feb,P Feb,february,mm per month,*mm~mo^-1*, +precipitation_03,precipitation_03,WorldClim_2.1_GISS-E2-1-G_ssp245_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Mar,P Mar,march,mm per month,*mm~mo^-1*, +precipitation_04,precipitation_04,WorldClim_2.1_GISS-E2-1-G_ssp245_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Apr,P Apr,april,mm per month,*mm~mo^-1*, +precipitation_05,precipitation_05,WorldClim_2.1_GISS-E2-1-G_ssp245_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation May,P May,may,mm per month,*mm~mo^-1*, +precipitation_06,precipitation_06,WorldClim_2.1_GISS-E2-1-G_ssp245_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jun,P Jun,june,mm per month,*mm~mo^-1*, +precipitation_07,precipitation_07,WorldClim_2.1_GISS-E2-1-G_ssp245_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jul,P Jul,july,mm per month,*mm~mo^-1*, +precipitation_08,precipitation_08,WorldClim_2.1_GISS-E2-1-G_ssp245_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Aug,P Aug,august,mm per month,*mm~mo^-1*, +precipitation_09,precipitation_09,WorldClim_2.1_GISS-E2-1-G_ssp245_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Sep,P Sep,september,mm per month,*mm~mo^-1*, +precipitation_10,precipitation_10,WorldClim_2.1_GISS-E2-1-G_ssp245_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Oct,P Oct,october,mm per month,*mm~mo^-1*, +precipitation_11,precipitation_11,WorldClim_2.1_GISS-E2-1-G_ssp245_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Nov,P Nov,november,mm per month,*mm~mo^-1*, +precipitation_12,precipitation_12,WorldClim_2.1_GISS-E2-1-G_ssp245_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Dec,P Dec,december,mm per month,*mm~mo^-1*, +temperature_min_01,temperature_min_01,WorldClim_2.1_GISS-E2-1-G_ssp245_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jan,min T Jan,january,degrees Celsius,*degree*C*, +temperature_min_02,temperature_min_02,WorldClim_2.1_GISS-E2-1-G_ssp245_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Feb,min T Feb,february,degrees Celsius,*degree*C*, +temperature_min_03,temperature_min_03,WorldClim_2.1_GISS-E2-1-G_ssp245_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Mar,min T Mar,march,degrees Celsius,*degree*C*, +temperature_min_04,temperature_min_04,WorldClim_2.1_GISS-E2-1-G_ssp245_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Apr,min T Apr,april,degrees Celsius,*degree*C*, +temperature_min_05,temperature_min_05,WorldClim_2.1_GISS-E2-1-G_ssp245_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature May,min T May,may,degrees Celsius,*degree*C*, +temperature_min_06,temperature_min_06,WorldClim_2.1_GISS-E2-1-G_ssp245_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jun,min T Jun,june,degrees Celsius,*degree*C*, +temperature_min_07,temperature_min_07,WorldClim_2.1_GISS-E2-1-G_ssp245_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jul,min T Jul,july,degrees Celsius,*degree*C*, +temperature_min_08,temperature_min_08,WorldClim_2.1_GISS-E2-1-G_ssp245_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Aug,min T Aug,august,degrees Celsius,*degree*C*, +temperature_min_09,temperature_min_09,WorldClim_2.1_GISS-E2-1-G_ssp245_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Sep,min T Sep,september,degrees Celsius,*degree*C*, +temperature_min_10,temperature_min_10,WorldClim_2.1_GISS-E2-1-G_ssp245_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Oct,min T Oct,october,degrees Celsius,*degree*C*, +temperature_min_11,temperature_min_11,WorldClim_2.1_GISS-E2-1-G_ssp245_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Nov,min T Nov,november,degrees Celsius,*degree*C*, +temperature_min_12,temperature_min_12,WorldClim_2.1_GISS-E2-1-G_ssp245_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Dec,min T Dec,december,degrees Celsius,*degree*C*, +temperature_max_01,temperature_max_01,WorldClim_2.1_GISS-E2-1-G_ssp245_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jan,max T Jan,january,degrees Celsius,*degree*C*, +temperature_max_02,temperature_max_02,WorldClim_2.1_GISS-E2-1-G_ssp245_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Feb,max T Feb,february,degrees Celsius,*degree*C*, +temperature_max_03,temperature_max_03,WorldClim_2.1_GISS-E2-1-G_ssp245_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Mar,max T Mar,march,degrees Celsius,*degree*C*, +temperature_max_04,temperature_max_04,WorldClim_2.1_GISS-E2-1-G_ssp245_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Apr,max T Apr,april,degrees Celsius,*degree*C*, +temperature_max_05,temperature_max_05,WorldClim_2.1_GISS-E2-1-G_ssp245_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature May,max T May,may,degrees Celsius,*degree*C*, +temperature_max_06,temperature_max_06,WorldClim_2.1_GISS-E2-1-G_ssp245_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jun,max T Jun,june,degrees Celsius,*degree*C*, +temperature_max_07,temperature_max_07,WorldClim_2.1_GISS-E2-1-G_ssp245_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jul,max T Jul,july,degrees Celsius,*degree*C*, +temperature_max_08,temperature_max_08,WorldClim_2.1_GISS-E2-1-G_ssp245_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Aug,max T Aug,august,degrees Celsius,*degree*C*, +temperature_max_09,temperature_max_09,WorldClim_2.1_GISS-E2-1-G_ssp245_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Sep,max T Sep,september,degrees Celsius,*degree*C*, +temperature_max_10,temperature_max_10,WorldClim_2.1_GISS-E2-1-G_ssp245_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Oct,max T Oct,october,degrees Celsius,*degree*C*, +temperature_max_11,temperature_max_11,WorldClim_2.1_GISS-E2-1-G_ssp245_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Nov,max T Nov,november,degrees Celsius,*degree*C*, +temperature_max_12,temperature_max_12,WorldClim_2.1_GISS-E2-1-G_ssp245_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Dec,max T Dec,december,degrees Celsius,*degree*C*, +bio01,bio01,WorldClim_2.1_GISS-E2-1-G_ssp370_10m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual mean temperature,ann. mean T,year,degrees Celsius,*degree*C*, +bio02,bio02,WorldClim_2.1_GISS-E2-1-G_ssp370_10m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean diurnal range,diurn. range,year,degrees Celsius,*degree*C*, +bio03,bio03,WorldClim_2.1_GISS-E2-1-G_ssp370_10m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,isothermality,isothermality,year,,, +bio04,bio04,WorldClim_2.1_GISS-E2-1-G_ssp370_10m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature seasonality,T season.,year,degrees Celsius,*degree*C*, +bio05,bio05,WorldClim_2.1_GISS-E2-1-G_ssp370_10m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature of warmest month,max. T of warmest mo.,year,degrees Celsius,*degree*C*, +bio06,bio06,WorldClim_2.1_GISS-E2-1-G_ssp370_10m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature of coldest month,min. T of coldest mo.,year,degrees Celsius,*degree*C*, +bio07,bio07,WorldClim_2.1_GISS-E2-1-G_ssp370_10m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature annual range (bio05-bio06),T ann. Range,year,degrees Celsius,*degree*C*, +bio08,bio08,WorldClim_2.1_GISS-E2-1-G_ssp370_10m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of wettest quarter,mean T of wettest qtr,year,degrees Celsius,*degree*C*, +bio09,bio09,WorldClim_2.1_GISS-E2-1-G_ssp370_10m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of driest quarter,mean T of driest qtr,year,degrees Celsius,*degree*C*, +bio10,bio10,WorldClim_2.1_GISS-E2-1-G_ssp370_10m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of warmest quarter,mean T of warmest qtr,year,degrees Celsius,*degree*C*, +bio11,bio11,WorldClim_2.1_GISS-E2-1-G_ssp370_10m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of coldest quarter,mean T of coldest qtr,year,degrees Celsius,*degree*C*, +bio12,bio12,WorldClim_2.1_GISS-E2-1-G_ssp370_10m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual precipitation,ann. P,year,mm per year,*mm~yr^-1*, +bio13,bio13,WorldClim_2.1_GISS-E2-1-G_ssp370_10m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest month,P of wettest mo.,year,mm per month,*mm~mo^-1*, +bio14,bio14,WorldClim_2.1_GISS-E2-1-G_ssp370_10m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest month,P of driest mo.,year,mm per month,*mm~mo^-1*, +bio15,bio15,WorldClim_2.1_GISS-E2-1-G_ssp370_10m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation seasonality (coeff var),P season.,year,,, +bio16,bio16,WorldClim_2.1_GISS-E2-1-G_ssp370_10m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest quarter,P of wettest qtr,year,mm per quarter,*mm~qtr^-1*, +bio17,bio17,WorldClim_2.1_GISS-E2-1-G_ssp370_10m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest quarter,P of driest qtr,year,mm per quarter,*mm~qtr^-1*, +bio18,bio18,WorldClim_2.1_GISS-E2-1-G_ssp370_10m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of warmest quarter,P of warmest qtr,year,mm per quarter,*mm~qtr^-1*, +bio19,bio19,WorldClim_2.1_GISS-E2-1-G_ssp370_10m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of coldest quarter,P of coldest qtr,year,mm per quarter,*mm~qtr^-1*, +precipitation_01,precipitation_01,WorldClim_2.1_GISS-E2-1-G_ssp370_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jan,P Jan,january,mm per month,*mm~mo^-1*, +precipitation_02,precipitation_02,WorldClim_2.1_GISS-E2-1-G_ssp370_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Feb,P Feb,february,mm per month,*mm~mo^-1*, +precipitation_03,precipitation_03,WorldClim_2.1_GISS-E2-1-G_ssp370_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Mar,P Mar,march,mm per month,*mm~mo^-1*, +precipitation_04,precipitation_04,WorldClim_2.1_GISS-E2-1-G_ssp370_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Apr,P Apr,april,mm per month,*mm~mo^-1*, +precipitation_05,precipitation_05,WorldClim_2.1_GISS-E2-1-G_ssp370_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation May,P May,may,mm per month,*mm~mo^-1*, +precipitation_06,precipitation_06,WorldClim_2.1_GISS-E2-1-G_ssp370_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jun,P Jun,june,mm per month,*mm~mo^-1*, +precipitation_07,precipitation_07,WorldClim_2.1_GISS-E2-1-G_ssp370_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jul,P Jul,july,mm per month,*mm~mo^-1*, +precipitation_08,precipitation_08,WorldClim_2.1_GISS-E2-1-G_ssp370_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Aug,P Aug,august,mm per month,*mm~mo^-1*, +precipitation_09,precipitation_09,WorldClim_2.1_GISS-E2-1-G_ssp370_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Sep,P Sep,september,mm per month,*mm~mo^-1*, +precipitation_10,precipitation_10,WorldClim_2.1_GISS-E2-1-G_ssp370_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Oct,P Oct,october,mm per month,*mm~mo^-1*, +precipitation_11,precipitation_11,WorldClim_2.1_GISS-E2-1-G_ssp370_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Nov,P Nov,november,mm per month,*mm~mo^-1*, +precipitation_12,precipitation_12,WorldClim_2.1_GISS-E2-1-G_ssp370_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Dec,P Dec,december,mm per month,*mm~mo^-1*, +temperature_min_01,temperature_min_01,WorldClim_2.1_GISS-E2-1-G_ssp370_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jan,min T Jan,january,degrees Celsius,*degree*C*, +temperature_min_02,temperature_min_02,WorldClim_2.1_GISS-E2-1-G_ssp370_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Feb,min T Feb,february,degrees Celsius,*degree*C*, +temperature_min_03,temperature_min_03,WorldClim_2.1_GISS-E2-1-G_ssp370_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Mar,min T Mar,march,degrees Celsius,*degree*C*, +temperature_min_04,temperature_min_04,WorldClim_2.1_GISS-E2-1-G_ssp370_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Apr,min T Apr,april,degrees Celsius,*degree*C*, +temperature_min_05,temperature_min_05,WorldClim_2.1_GISS-E2-1-G_ssp370_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature May,min T May,may,degrees Celsius,*degree*C*, +temperature_min_06,temperature_min_06,WorldClim_2.1_GISS-E2-1-G_ssp370_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jun,min T Jun,june,degrees Celsius,*degree*C*, +temperature_min_07,temperature_min_07,WorldClim_2.1_GISS-E2-1-G_ssp370_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jul,min T Jul,july,degrees Celsius,*degree*C*, +temperature_min_08,temperature_min_08,WorldClim_2.1_GISS-E2-1-G_ssp370_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Aug,min T Aug,august,degrees Celsius,*degree*C*, +temperature_min_09,temperature_min_09,WorldClim_2.1_GISS-E2-1-G_ssp370_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Sep,min T Sep,september,degrees Celsius,*degree*C*, +temperature_min_10,temperature_min_10,WorldClim_2.1_GISS-E2-1-G_ssp370_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Oct,min T Oct,october,degrees Celsius,*degree*C*, +temperature_min_11,temperature_min_11,WorldClim_2.1_GISS-E2-1-G_ssp370_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Nov,min T Nov,november,degrees Celsius,*degree*C*, +temperature_min_12,temperature_min_12,WorldClim_2.1_GISS-E2-1-G_ssp370_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Dec,min T Dec,december,degrees Celsius,*degree*C*, +temperature_max_01,temperature_max_01,WorldClim_2.1_GISS-E2-1-G_ssp370_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jan,max T Jan,january,degrees Celsius,*degree*C*, +temperature_max_02,temperature_max_02,WorldClim_2.1_GISS-E2-1-G_ssp370_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Feb,max T Feb,february,degrees Celsius,*degree*C*, +temperature_max_03,temperature_max_03,WorldClim_2.1_GISS-E2-1-G_ssp370_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Mar,max T Mar,march,degrees Celsius,*degree*C*, +temperature_max_04,temperature_max_04,WorldClim_2.1_GISS-E2-1-G_ssp370_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Apr,max T Apr,april,degrees Celsius,*degree*C*, +temperature_max_05,temperature_max_05,WorldClim_2.1_GISS-E2-1-G_ssp370_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature May,max T May,may,degrees Celsius,*degree*C*, +temperature_max_06,temperature_max_06,WorldClim_2.1_GISS-E2-1-G_ssp370_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jun,max T Jun,june,degrees Celsius,*degree*C*, +temperature_max_07,temperature_max_07,WorldClim_2.1_GISS-E2-1-G_ssp370_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jul,max T Jul,july,degrees Celsius,*degree*C*, +temperature_max_08,temperature_max_08,WorldClim_2.1_GISS-E2-1-G_ssp370_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Aug,max T Aug,august,degrees Celsius,*degree*C*, +temperature_max_09,temperature_max_09,WorldClim_2.1_GISS-E2-1-G_ssp370_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Sep,max T Sep,september,degrees Celsius,*degree*C*, +temperature_max_10,temperature_max_10,WorldClim_2.1_GISS-E2-1-G_ssp370_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Oct,max T Oct,october,degrees Celsius,*degree*C*, +temperature_max_11,temperature_max_11,WorldClim_2.1_GISS-E2-1-G_ssp370_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Nov,max T Nov,november,degrees Celsius,*degree*C*, +temperature_max_12,temperature_max_12,WorldClim_2.1_GISS-E2-1-G_ssp370_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Dec,max T Dec,december,degrees Celsius,*degree*C*, +bio01,bio01,WorldClim_2.1_GISS-E2-1-G_ssp370_5m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual mean temperature,ann. mean T,year,degrees Celsius,*degree*C*, +bio02,bio02,WorldClim_2.1_GISS-E2-1-G_ssp370_5m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean diurnal range,diurn. range,year,degrees Celsius,*degree*C*, +bio03,bio03,WorldClim_2.1_GISS-E2-1-G_ssp370_5m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,isothermality,isothermality,year,,, +bio04,bio04,WorldClim_2.1_GISS-E2-1-G_ssp370_5m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature seasonality,T season.,year,degrees Celsius,*degree*C*, +bio05,bio05,WorldClim_2.1_GISS-E2-1-G_ssp370_5m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature of warmest month,max. T of warmest mo.,year,degrees Celsius,*degree*C*, +bio06,bio06,WorldClim_2.1_GISS-E2-1-G_ssp370_5m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature of coldest month,min. T of coldest mo.,year,degrees Celsius,*degree*C*, +bio07,bio07,WorldClim_2.1_GISS-E2-1-G_ssp370_5m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature annual range (bio05-bio06),T ann. Range,year,degrees Celsius,*degree*C*, +bio08,bio08,WorldClim_2.1_GISS-E2-1-G_ssp370_5m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of wettest quarter,mean T of wettest qtr,year,degrees Celsius,*degree*C*, +bio09,bio09,WorldClim_2.1_GISS-E2-1-G_ssp370_5m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of driest quarter,mean T of driest qtr,year,degrees Celsius,*degree*C*, +bio10,bio10,WorldClim_2.1_GISS-E2-1-G_ssp370_5m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of warmest quarter,mean T of warmest qtr,year,degrees Celsius,*degree*C*, +bio11,bio11,WorldClim_2.1_GISS-E2-1-G_ssp370_5m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of coldest quarter,mean T of coldest qtr,year,degrees Celsius,*degree*C*, +bio12,bio12,WorldClim_2.1_GISS-E2-1-G_ssp370_5m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual precipitation,ann. P,year,mm per year,*mm~yr^-1*, +bio13,bio13,WorldClim_2.1_GISS-E2-1-G_ssp370_5m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest month,P of wettest mo.,year,mm per month,*mm~mo^-1*, +bio14,bio14,WorldClim_2.1_GISS-E2-1-G_ssp370_5m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest month,P of driest mo.,year,mm per month,*mm~mo^-1*, +bio15,bio15,WorldClim_2.1_GISS-E2-1-G_ssp370_5m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation seasonality (coeff var),P season.,year,,, +bio16,bio16,WorldClim_2.1_GISS-E2-1-G_ssp370_5m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest quarter,P of wettest qtr,year,mm per quarter,*mm~qtr^-1*, +bio17,bio17,WorldClim_2.1_GISS-E2-1-G_ssp370_5m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest quarter,P of driest qtr,year,mm per quarter,*mm~qtr^-1*, +bio18,bio18,WorldClim_2.1_GISS-E2-1-G_ssp370_5m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of warmest quarter,P of warmest qtr,year,mm per quarter,*mm~qtr^-1*, +bio19,bio19,WorldClim_2.1_GISS-E2-1-G_ssp370_5m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of coldest quarter,P of coldest qtr,year,mm per quarter,*mm~qtr^-1*, +precipitation_01,precipitation_01,WorldClim_2.1_GISS-E2-1-G_ssp370_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jan,P Jan,january,mm per month,*mm~mo^-1*, +precipitation_02,precipitation_02,WorldClim_2.1_GISS-E2-1-G_ssp370_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Feb,P Feb,february,mm per month,*mm~mo^-1*, +precipitation_03,precipitation_03,WorldClim_2.1_GISS-E2-1-G_ssp370_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Mar,P Mar,march,mm per month,*mm~mo^-1*, +precipitation_04,precipitation_04,WorldClim_2.1_GISS-E2-1-G_ssp370_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Apr,P Apr,april,mm per month,*mm~mo^-1*, +precipitation_05,precipitation_05,WorldClim_2.1_GISS-E2-1-G_ssp370_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation May,P May,may,mm per month,*mm~mo^-1*, +precipitation_06,precipitation_06,WorldClim_2.1_GISS-E2-1-G_ssp370_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jun,P Jun,june,mm per month,*mm~mo^-1*, +precipitation_07,precipitation_07,WorldClim_2.1_GISS-E2-1-G_ssp370_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jul,P Jul,july,mm per month,*mm~mo^-1*, +precipitation_08,precipitation_08,WorldClim_2.1_GISS-E2-1-G_ssp370_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Aug,P Aug,august,mm per month,*mm~mo^-1*, +precipitation_09,precipitation_09,WorldClim_2.1_GISS-E2-1-G_ssp370_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Sep,P Sep,september,mm per month,*mm~mo^-1*, +precipitation_10,precipitation_10,WorldClim_2.1_GISS-E2-1-G_ssp370_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Oct,P Oct,october,mm per month,*mm~mo^-1*, +precipitation_11,precipitation_11,WorldClim_2.1_GISS-E2-1-G_ssp370_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Nov,P Nov,november,mm per month,*mm~mo^-1*, +precipitation_12,precipitation_12,WorldClim_2.1_GISS-E2-1-G_ssp370_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Dec,P Dec,december,mm per month,*mm~mo^-1*, +temperature_min_01,temperature_min_01,WorldClim_2.1_GISS-E2-1-G_ssp370_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jan,min T Jan,january,degrees Celsius,*degree*C*, +temperature_min_02,temperature_min_02,WorldClim_2.1_GISS-E2-1-G_ssp370_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Feb,min T Feb,february,degrees Celsius,*degree*C*, +temperature_min_03,temperature_min_03,WorldClim_2.1_GISS-E2-1-G_ssp370_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Mar,min T Mar,march,degrees Celsius,*degree*C*, +temperature_min_04,temperature_min_04,WorldClim_2.1_GISS-E2-1-G_ssp370_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Apr,min T Apr,april,degrees Celsius,*degree*C*, +temperature_min_05,temperature_min_05,WorldClim_2.1_GISS-E2-1-G_ssp370_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature May,min T May,may,degrees Celsius,*degree*C*, +temperature_min_06,temperature_min_06,WorldClim_2.1_GISS-E2-1-G_ssp370_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jun,min T Jun,june,degrees Celsius,*degree*C*, +temperature_min_07,temperature_min_07,WorldClim_2.1_GISS-E2-1-G_ssp370_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jul,min T Jul,july,degrees Celsius,*degree*C*, +temperature_min_08,temperature_min_08,WorldClim_2.1_GISS-E2-1-G_ssp370_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Aug,min T Aug,august,degrees Celsius,*degree*C*, +temperature_min_09,temperature_min_09,WorldClim_2.1_GISS-E2-1-G_ssp370_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Sep,min T Sep,september,degrees Celsius,*degree*C*, +temperature_min_10,temperature_min_10,WorldClim_2.1_GISS-E2-1-G_ssp370_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Oct,min T Oct,october,degrees Celsius,*degree*C*, +temperature_min_11,temperature_min_11,WorldClim_2.1_GISS-E2-1-G_ssp370_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Nov,min T Nov,november,degrees Celsius,*degree*C*, +temperature_min_12,temperature_min_12,WorldClim_2.1_GISS-E2-1-G_ssp370_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Dec,min T Dec,december,degrees Celsius,*degree*C*, +temperature_max_01,temperature_max_01,WorldClim_2.1_GISS-E2-1-G_ssp370_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jan,max T Jan,january,degrees Celsius,*degree*C*, +temperature_max_02,temperature_max_02,WorldClim_2.1_GISS-E2-1-G_ssp370_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Feb,max T Feb,february,degrees Celsius,*degree*C*, +temperature_max_03,temperature_max_03,WorldClim_2.1_GISS-E2-1-G_ssp370_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Mar,max T Mar,march,degrees Celsius,*degree*C*, +temperature_max_04,temperature_max_04,WorldClim_2.1_GISS-E2-1-G_ssp370_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Apr,max T Apr,april,degrees Celsius,*degree*C*, +temperature_max_05,temperature_max_05,WorldClim_2.1_GISS-E2-1-G_ssp370_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature May,max T May,may,degrees Celsius,*degree*C*, +temperature_max_06,temperature_max_06,WorldClim_2.1_GISS-E2-1-G_ssp370_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jun,max T Jun,june,degrees Celsius,*degree*C*, +temperature_max_07,temperature_max_07,WorldClim_2.1_GISS-E2-1-G_ssp370_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jul,max T Jul,july,degrees Celsius,*degree*C*, +temperature_max_08,temperature_max_08,WorldClim_2.1_GISS-E2-1-G_ssp370_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Aug,max T Aug,august,degrees Celsius,*degree*C*, +temperature_max_09,temperature_max_09,WorldClim_2.1_GISS-E2-1-G_ssp370_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Sep,max T Sep,september,degrees Celsius,*degree*C*, +temperature_max_10,temperature_max_10,WorldClim_2.1_GISS-E2-1-G_ssp370_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Oct,max T Oct,october,degrees Celsius,*degree*C*, +temperature_max_11,temperature_max_11,WorldClim_2.1_GISS-E2-1-G_ssp370_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Nov,max T Nov,november,degrees Celsius,*degree*C*, +temperature_max_12,temperature_max_12,WorldClim_2.1_GISS-E2-1-G_ssp370_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Dec,max T Dec,december,degrees Celsius,*degree*C*, +bio01,bio01,WorldClim_2.1_GISS-E2-1-G_ssp585_10m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual mean temperature,ann. mean T,year,degrees Celsius,*degree*C*, +bio02,bio02,WorldClim_2.1_GISS-E2-1-G_ssp585_10m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean diurnal range,diurn. range,year,degrees Celsius,*degree*C*, +bio03,bio03,WorldClim_2.1_GISS-E2-1-G_ssp585_10m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,isothermality,isothermality,year,,, +bio04,bio04,WorldClim_2.1_GISS-E2-1-G_ssp585_10m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature seasonality,T season.,year,degrees Celsius,*degree*C*, +bio05,bio05,WorldClim_2.1_GISS-E2-1-G_ssp585_10m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature of warmest month,max. T of warmest mo.,year,degrees Celsius,*degree*C*, +bio06,bio06,WorldClim_2.1_GISS-E2-1-G_ssp585_10m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature of coldest month,min. T of coldest mo.,year,degrees Celsius,*degree*C*, +bio07,bio07,WorldClim_2.1_GISS-E2-1-G_ssp585_10m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature annual range (bio05-bio06),T ann. Range,year,degrees Celsius,*degree*C*, +bio08,bio08,WorldClim_2.1_GISS-E2-1-G_ssp585_10m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of wettest quarter,mean T of wettest qtr,year,degrees Celsius,*degree*C*, +bio09,bio09,WorldClim_2.1_GISS-E2-1-G_ssp585_10m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of driest quarter,mean T of driest qtr,year,degrees Celsius,*degree*C*, +bio10,bio10,WorldClim_2.1_GISS-E2-1-G_ssp585_10m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of warmest quarter,mean T of warmest qtr,year,degrees Celsius,*degree*C*, +bio11,bio11,WorldClim_2.1_GISS-E2-1-G_ssp585_10m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of coldest quarter,mean T of coldest qtr,year,degrees Celsius,*degree*C*, +bio12,bio12,WorldClim_2.1_GISS-E2-1-G_ssp585_10m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual precipitation,ann. P,year,mm per year,*mm~yr^-1*, +bio13,bio13,WorldClim_2.1_GISS-E2-1-G_ssp585_10m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest month,P of wettest mo.,year,mm per month,*mm~mo^-1*, +bio14,bio14,WorldClim_2.1_GISS-E2-1-G_ssp585_10m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest month,P of driest mo.,year,mm per month,*mm~mo^-1*, +bio15,bio15,WorldClim_2.1_GISS-E2-1-G_ssp585_10m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation seasonality (coeff var),P season.,year,,, +bio16,bio16,WorldClim_2.1_GISS-E2-1-G_ssp585_10m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest quarter,P of wettest qtr,year,mm per quarter,*mm~qtr^-1*, +bio17,bio17,WorldClim_2.1_GISS-E2-1-G_ssp585_10m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest quarter,P of driest qtr,year,mm per quarter,*mm~qtr^-1*, +bio18,bio18,WorldClim_2.1_GISS-E2-1-G_ssp585_10m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of warmest quarter,P of warmest qtr,year,mm per quarter,*mm~qtr^-1*, +bio19,bio19,WorldClim_2.1_GISS-E2-1-G_ssp585_10m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of coldest quarter,P of coldest qtr,year,mm per quarter,*mm~qtr^-1*, +precipitation_01,precipitation_01,WorldClim_2.1_GISS-E2-1-G_ssp585_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jan,P Jan,january,mm per month,*mm~mo^-1*, +precipitation_02,precipitation_02,WorldClim_2.1_GISS-E2-1-G_ssp585_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Feb,P Feb,february,mm per month,*mm~mo^-1*, +precipitation_03,precipitation_03,WorldClim_2.1_GISS-E2-1-G_ssp585_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Mar,P Mar,march,mm per month,*mm~mo^-1*, +precipitation_04,precipitation_04,WorldClim_2.1_GISS-E2-1-G_ssp585_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Apr,P Apr,april,mm per month,*mm~mo^-1*, +precipitation_05,precipitation_05,WorldClim_2.1_GISS-E2-1-G_ssp585_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation May,P May,may,mm per month,*mm~mo^-1*, +precipitation_06,precipitation_06,WorldClim_2.1_GISS-E2-1-G_ssp585_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jun,P Jun,june,mm per month,*mm~mo^-1*, +precipitation_07,precipitation_07,WorldClim_2.1_GISS-E2-1-G_ssp585_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jul,P Jul,july,mm per month,*mm~mo^-1*, +precipitation_08,precipitation_08,WorldClim_2.1_GISS-E2-1-G_ssp585_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Aug,P Aug,august,mm per month,*mm~mo^-1*, +precipitation_09,precipitation_09,WorldClim_2.1_GISS-E2-1-G_ssp585_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Sep,P Sep,september,mm per month,*mm~mo^-1*, +precipitation_10,precipitation_10,WorldClim_2.1_GISS-E2-1-G_ssp585_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Oct,P Oct,october,mm per month,*mm~mo^-1*, +precipitation_11,precipitation_11,WorldClim_2.1_GISS-E2-1-G_ssp585_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Nov,P Nov,november,mm per month,*mm~mo^-1*, +precipitation_12,precipitation_12,WorldClim_2.1_GISS-E2-1-G_ssp585_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Dec,P Dec,december,mm per month,*mm~mo^-1*, +temperature_min_01,temperature_min_01,WorldClim_2.1_GISS-E2-1-G_ssp585_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jan,min T Jan,january,degrees Celsius,*degree*C*, +temperature_min_02,temperature_min_02,WorldClim_2.1_GISS-E2-1-G_ssp585_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Feb,min T Feb,february,degrees Celsius,*degree*C*, +temperature_min_03,temperature_min_03,WorldClim_2.1_GISS-E2-1-G_ssp585_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Mar,min T Mar,march,degrees Celsius,*degree*C*, +temperature_min_04,temperature_min_04,WorldClim_2.1_GISS-E2-1-G_ssp585_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Apr,min T Apr,april,degrees Celsius,*degree*C*, +temperature_min_05,temperature_min_05,WorldClim_2.1_GISS-E2-1-G_ssp585_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature May,min T May,may,degrees Celsius,*degree*C*, +temperature_min_06,temperature_min_06,WorldClim_2.1_GISS-E2-1-G_ssp585_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jun,min T Jun,june,degrees Celsius,*degree*C*, +temperature_min_07,temperature_min_07,WorldClim_2.1_GISS-E2-1-G_ssp585_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jul,min T Jul,july,degrees Celsius,*degree*C*, +temperature_min_08,temperature_min_08,WorldClim_2.1_GISS-E2-1-G_ssp585_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Aug,min T Aug,august,degrees Celsius,*degree*C*, +temperature_min_09,temperature_min_09,WorldClim_2.1_GISS-E2-1-G_ssp585_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Sep,min T Sep,september,degrees Celsius,*degree*C*, +temperature_min_10,temperature_min_10,WorldClim_2.1_GISS-E2-1-G_ssp585_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Oct,min T Oct,october,degrees Celsius,*degree*C*, +temperature_min_11,temperature_min_11,WorldClim_2.1_GISS-E2-1-G_ssp585_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Nov,min T Nov,november,degrees Celsius,*degree*C*, +temperature_min_12,temperature_min_12,WorldClim_2.1_GISS-E2-1-G_ssp585_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Dec,min T Dec,december,degrees Celsius,*degree*C*, +temperature_max_01,temperature_max_01,WorldClim_2.1_GISS-E2-1-G_ssp585_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jan,max T Jan,january,degrees Celsius,*degree*C*, +temperature_max_02,temperature_max_02,WorldClim_2.1_GISS-E2-1-G_ssp585_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Feb,max T Feb,february,degrees Celsius,*degree*C*, +temperature_max_03,temperature_max_03,WorldClim_2.1_GISS-E2-1-G_ssp585_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Mar,max T Mar,march,degrees Celsius,*degree*C*, +temperature_max_04,temperature_max_04,WorldClim_2.1_GISS-E2-1-G_ssp585_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Apr,max T Apr,april,degrees Celsius,*degree*C*, +temperature_max_05,temperature_max_05,WorldClim_2.1_GISS-E2-1-G_ssp585_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature May,max T May,may,degrees Celsius,*degree*C*, +temperature_max_06,temperature_max_06,WorldClim_2.1_GISS-E2-1-G_ssp585_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jun,max T Jun,june,degrees Celsius,*degree*C*, +temperature_max_07,temperature_max_07,WorldClim_2.1_GISS-E2-1-G_ssp585_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jul,max T Jul,july,degrees Celsius,*degree*C*, +temperature_max_08,temperature_max_08,WorldClim_2.1_GISS-E2-1-G_ssp585_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Aug,max T Aug,august,degrees Celsius,*degree*C*, +temperature_max_09,temperature_max_09,WorldClim_2.1_GISS-E2-1-G_ssp585_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Sep,max T Sep,september,degrees Celsius,*degree*C*, +temperature_max_10,temperature_max_10,WorldClim_2.1_GISS-E2-1-G_ssp585_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Oct,max T Oct,october,degrees Celsius,*degree*C*, +temperature_max_11,temperature_max_11,WorldClim_2.1_GISS-E2-1-G_ssp585_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Nov,max T Nov,november,degrees Celsius,*degree*C*, +temperature_max_12,temperature_max_12,WorldClim_2.1_GISS-E2-1-G_ssp585_10m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Dec,max T Dec,december,degrees Celsius,*degree*C*, +bio01,bio01,WorldClim_2.1_GISS-E2-1-G_ssp585_5m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual mean temperature,ann. mean T,year,degrees Celsius,*degree*C*, +bio02,bio02,WorldClim_2.1_GISS-E2-1-G_ssp585_5m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean diurnal range,diurn. range,year,degrees Celsius,*degree*C*, +bio03,bio03,WorldClim_2.1_GISS-E2-1-G_ssp585_5m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,isothermality,isothermality,year,,, +bio04,bio04,WorldClim_2.1_GISS-E2-1-G_ssp585_5m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature seasonality,T season.,year,degrees Celsius,*degree*C*, +bio05,bio05,WorldClim_2.1_GISS-E2-1-G_ssp585_5m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature of warmest month,max. T of warmest mo.,year,degrees Celsius,*degree*C*, +bio06,bio06,WorldClim_2.1_GISS-E2-1-G_ssp585_5m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature of coldest month,min. T of coldest mo.,year,degrees Celsius,*degree*C*, +bio07,bio07,WorldClim_2.1_GISS-E2-1-G_ssp585_5m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature annual range (bio05-bio06),T ann. Range,year,degrees Celsius,*degree*C*, +bio08,bio08,WorldClim_2.1_GISS-E2-1-G_ssp585_5m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of wettest quarter,mean T of wettest qtr,year,degrees Celsius,*degree*C*, +bio09,bio09,WorldClim_2.1_GISS-E2-1-G_ssp585_5m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of driest quarter,mean T of driest qtr,year,degrees Celsius,*degree*C*, +bio10,bio10,WorldClim_2.1_GISS-E2-1-G_ssp585_5m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of warmest quarter,mean T of warmest qtr,year,degrees Celsius,*degree*C*, +bio11,bio11,WorldClim_2.1_GISS-E2-1-G_ssp585_5m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of coldest quarter,mean T of coldest qtr,year,degrees Celsius,*degree*C*, +bio12,bio12,WorldClim_2.1_GISS-E2-1-G_ssp585_5m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual precipitation,ann. P,year,mm per year,*mm~yr^-1*, +bio13,bio13,WorldClim_2.1_GISS-E2-1-G_ssp585_5m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest month,P of wettest mo.,year,mm per month,*mm~mo^-1*, +bio14,bio14,WorldClim_2.1_GISS-E2-1-G_ssp585_5m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest month,P of driest mo.,year,mm per month,*mm~mo^-1*, +bio15,bio15,WorldClim_2.1_GISS-E2-1-G_ssp585_5m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation seasonality (coeff var),P season.,year,,, +bio16,bio16,WorldClim_2.1_GISS-E2-1-G_ssp585_5m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest quarter,P of wettest qtr,year,mm per quarter,*mm~qtr^-1*, +bio17,bio17,WorldClim_2.1_GISS-E2-1-G_ssp585_5m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest quarter,P of driest qtr,year,mm per quarter,*mm~qtr^-1*, +bio18,bio18,WorldClim_2.1_GISS-E2-1-G_ssp585_5m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of warmest quarter,P of warmest qtr,year,mm per quarter,*mm~qtr^-1*, +bio19,bio19,WorldClim_2.1_GISS-E2-1-G_ssp585_5m,FALSE,WorldClim_2.1_GISS-E2-1-G_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of coldest quarter,P of coldest qtr,year,mm per quarter,*mm~qtr^-1*, +precipitation_01,precipitation_01,WorldClim_2.1_GISS-E2-1-G_ssp585_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jan,P Jan,january,mm per month,*mm~mo^-1*, +precipitation_02,precipitation_02,WorldClim_2.1_GISS-E2-1-G_ssp585_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Feb,P Feb,february,mm per month,*mm~mo^-1*, +precipitation_03,precipitation_03,WorldClim_2.1_GISS-E2-1-G_ssp585_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Mar,P Mar,march,mm per month,*mm~mo^-1*, +precipitation_04,precipitation_04,WorldClim_2.1_GISS-E2-1-G_ssp585_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Apr,P Apr,april,mm per month,*mm~mo^-1*, +precipitation_05,precipitation_05,WorldClim_2.1_GISS-E2-1-G_ssp585_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation May,P May,may,mm per month,*mm~mo^-1*, +precipitation_06,precipitation_06,WorldClim_2.1_GISS-E2-1-G_ssp585_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jun,P Jun,june,mm per month,*mm~mo^-1*, +precipitation_07,precipitation_07,WorldClim_2.1_GISS-E2-1-G_ssp585_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jul,P Jul,july,mm per month,*mm~mo^-1*, +precipitation_08,precipitation_08,WorldClim_2.1_GISS-E2-1-G_ssp585_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Aug,P Aug,august,mm per month,*mm~mo^-1*, +precipitation_09,precipitation_09,WorldClim_2.1_GISS-E2-1-G_ssp585_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Sep,P Sep,september,mm per month,*mm~mo^-1*, +precipitation_10,precipitation_10,WorldClim_2.1_GISS-E2-1-G_ssp585_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Oct,P Oct,october,mm per month,*mm~mo^-1*, +precipitation_11,precipitation_11,WorldClim_2.1_GISS-E2-1-G_ssp585_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Nov,P Nov,november,mm per month,*mm~mo^-1*, +precipitation_12,precipitation_12,WorldClim_2.1_GISS-E2-1-G_ssp585_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Dec,P Dec,december,mm per month,*mm~mo^-1*, +temperature_min_01,temperature_min_01,WorldClim_2.1_GISS-E2-1-G_ssp585_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jan,min T Jan,january,degrees Celsius,*degree*C*, +temperature_min_02,temperature_min_02,WorldClim_2.1_GISS-E2-1-G_ssp585_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Feb,min T Feb,february,degrees Celsius,*degree*C*, +temperature_min_03,temperature_min_03,WorldClim_2.1_GISS-E2-1-G_ssp585_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Mar,min T Mar,march,degrees Celsius,*degree*C*, +temperature_min_04,temperature_min_04,WorldClim_2.1_GISS-E2-1-G_ssp585_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Apr,min T Apr,april,degrees Celsius,*degree*C*, +temperature_min_05,temperature_min_05,WorldClim_2.1_GISS-E2-1-G_ssp585_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature May,min T May,may,degrees Celsius,*degree*C*, +temperature_min_06,temperature_min_06,WorldClim_2.1_GISS-E2-1-G_ssp585_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jun,min T Jun,june,degrees Celsius,*degree*C*, +temperature_min_07,temperature_min_07,WorldClim_2.1_GISS-E2-1-G_ssp585_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jul,min T Jul,july,degrees Celsius,*degree*C*, +temperature_min_08,temperature_min_08,WorldClim_2.1_GISS-E2-1-G_ssp585_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Aug,min T Aug,august,degrees Celsius,*degree*C*, +temperature_min_09,temperature_min_09,WorldClim_2.1_GISS-E2-1-G_ssp585_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Sep,min T Sep,september,degrees Celsius,*degree*C*, +temperature_min_10,temperature_min_10,WorldClim_2.1_GISS-E2-1-G_ssp585_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Oct,min T Oct,october,degrees Celsius,*degree*C*, +temperature_min_11,temperature_min_11,WorldClim_2.1_GISS-E2-1-G_ssp585_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Nov,min T Nov,november,degrees Celsius,*degree*C*, +temperature_min_12,temperature_min_12,WorldClim_2.1_GISS-E2-1-G_ssp585_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Dec,min T Dec,december,degrees Celsius,*degree*C*, +temperature_max_01,temperature_max_01,WorldClim_2.1_GISS-E2-1-G_ssp585_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jan,max T Jan,january,degrees Celsius,*degree*C*, +temperature_max_02,temperature_max_02,WorldClim_2.1_GISS-E2-1-G_ssp585_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Feb,max T Feb,february,degrees Celsius,*degree*C*, +temperature_max_03,temperature_max_03,WorldClim_2.1_GISS-E2-1-G_ssp585_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Mar,max T Mar,march,degrees Celsius,*degree*C*, +temperature_max_04,temperature_max_04,WorldClim_2.1_GISS-E2-1-G_ssp585_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Apr,max T Apr,april,degrees Celsius,*degree*C*, +temperature_max_05,temperature_max_05,WorldClim_2.1_GISS-E2-1-G_ssp585_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature May,max T May,may,degrees Celsius,*degree*C*, +temperature_max_06,temperature_max_06,WorldClim_2.1_GISS-E2-1-G_ssp585_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jun,max T Jun,june,degrees Celsius,*degree*C*, +temperature_max_07,temperature_max_07,WorldClim_2.1_GISS-E2-1-G_ssp585_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jul,max T Jul,july,degrees Celsius,*degree*C*, +temperature_max_08,temperature_max_08,WorldClim_2.1_GISS-E2-1-G_ssp585_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Aug,max T Aug,august,degrees Celsius,*degree*C*, +temperature_max_09,temperature_max_09,WorldClim_2.1_GISS-E2-1-G_ssp585_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Sep,max T Sep,september,degrees Celsius,*degree*C*, +temperature_max_10,temperature_max_10,WorldClim_2.1_GISS-E2-1-G_ssp585_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Oct,max T Oct,october,degrees Celsius,*degree*C*, +temperature_max_11,temperature_max_11,WorldClim_2.1_GISS-E2-1-G_ssp585_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Nov,max T Nov,november,degrees Celsius,*degree*C*, +temperature_max_12,temperature_max_12,WorldClim_2.1_GISS-E2-1-G_ssp585_5m,TRUE,WorldClim_2.1_GISS-E2-1-G_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Dec,max T Dec,december,degrees Celsius,*degree*C*, +bio01,bio01,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual mean temperature,ann. mean T,year,degrees Celsius,*degree*C*, +bio02,bio02,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean diurnal range,diurn. range,year,degrees Celsius,*degree*C*, +bio03,bio03,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,isothermality,isothermality,year,,, +bio04,bio04,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature seasonality,T season.,year,degrees Celsius,*degree*C*, +bio05,bio05,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature of warmest month,max. T of warmest mo.,year,degrees Celsius,*degree*C*, +bio06,bio06,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature of coldest month,min. T of coldest mo.,year,degrees Celsius,*degree*C*, +bio07,bio07,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature annual range (bio05-bio06),T ann. Range,year,degrees Celsius,*degree*C*, +bio08,bio08,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of wettest quarter,mean T of wettest qtr,year,degrees Celsius,*degree*C*, +bio09,bio09,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of driest quarter,mean T of driest qtr,year,degrees Celsius,*degree*C*, +bio10,bio10,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of warmest quarter,mean T of warmest qtr,year,degrees Celsius,*degree*C*, +bio11,bio11,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of coldest quarter,mean T of coldest qtr,year,degrees Celsius,*degree*C*, +bio12,bio12,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual precipitation,ann. P,year,mm per year,*mm~yr^-1*, +bio13,bio13,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest month,P of wettest mo.,year,mm per month,*mm~mo^-1*, +bio14,bio14,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest month,P of driest mo.,year,mm per month,*mm~mo^-1*, +bio15,bio15,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation seasonality (coeff var),P season.,year,,, +bio16,bio16,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest quarter,P of wettest qtr,year,mm per quarter,*mm~qtr^-1*, +bio17,bio17,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest quarter,P of driest qtr,year,mm per quarter,*mm~qtr^-1*, +bio18,bio18,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of warmest quarter,P of warmest qtr,year,mm per quarter,*mm~qtr^-1*, +bio19,bio19,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of coldest quarter,P of coldest qtr,year,mm per quarter,*mm~qtr^-1*, +precipitation_01,precipitation_01,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jan,P Jan,january,mm per month,*mm~mo^-1*, +precipitation_02,precipitation_02,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Feb,P Feb,february,mm per month,*mm~mo^-1*, +precipitation_03,precipitation_03,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Mar,P Mar,march,mm per month,*mm~mo^-1*, +precipitation_04,precipitation_04,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Apr,P Apr,april,mm per month,*mm~mo^-1*, +precipitation_05,precipitation_05,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation May,P May,may,mm per month,*mm~mo^-1*, +precipitation_06,precipitation_06,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jun,P Jun,june,mm per month,*mm~mo^-1*, +precipitation_07,precipitation_07,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jul,P Jul,july,mm per month,*mm~mo^-1*, +precipitation_08,precipitation_08,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Aug,P Aug,august,mm per month,*mm~mo^-1*, +precipitation_09,precipitation_09,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Sep,P Sep,september,mm per month,*mm~mo^-1*, +precipitation_10,precipitation_10,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Oct,P Oct,october,mm per month,*mm~mo^-1*, +precipitation_11,precipitation_11,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Nov,P Nov,november,mm per month,*mm~mo^-1*, +precipitation_12,precipitation_12,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Dec,P Dec,december,mm per month,*mm~mo^-1*, +temperature_min_01,temperature_min_01,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jan,min T Jan,january,degrees Celsius,*degree*C*, +temperature_min_02,temperature_min_02,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Feb,min T Feb,february,degrees Celsius,*degree*C*, +temperature_min_03,temperature_min_03,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Mar,min T Mar,march,degrees Celsius,*degree*C*, +temperature_min_04,temperature_min_04,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Apr,min T Apr,april,degrees Celsius,*degree*C*, +temperature_min_05,temperature_min_05,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature May,min T May,may,degrees Celsius,*degree*C*, +temperature_min_06,temperature_min_06,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jun,min T Jun,june,degrees Celsius,*degree*C*, +temperature_min_07,temperature_min_07,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jul,min T Jul,july,degrees Celsius,*degree*C*, +temperature_min_08,temperature_min_08,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Aug,min T Aug,august,degrees Celsius,*degree*C*, +temperature_min_09,temperature_min_09,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Sep,min T Sep,september,degrees Celsius,*degree*C*, +temperature_min_10,temperature_min_10,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Oct,min T Oct,october,degrees Celsius,*degree*C*, +temperature_min_11,temperature_min_11,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Nov,min T Nov,november,degrees Celsius,*degree*C*, +temperature_min_12,temperature_min_12,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Dec,min T Dec,december,degrees Celsius,*degree*C*, +temperature_max_01,temperature_max_01,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jan,max T Jan,january,degrees Celsius,*degree*C*, +temperature_max_02,temperature_max_02,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Feb,max T Feb,february,degrees Celsius,*degree*C*, +temperature_max_03,temperature_max_03,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Mar,max T Mar,march,degrees Celsius,*degree*C*, +temperature_max_04,temperature_max_04,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Apr,max T Apr,april,degrees Celsius,*degree*C*, +temperature_max_05,temperature_max_05,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature May,max T May,may,degrees Celsius,*degree*C*, +temperature_max_06,temperature_max_06,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jun,max T Jun,june,degrees Celsius,*degree*C*, +temperature_max_07,temperature_max_07,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jul,max T Jul,july,degrees Celsius,*degree*C*, +temperature_max_08,temperature_max_08,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Aug,max T Aug,august,degrees Celsius,*degree*C*, +temperature_max_09,temperature_max_09,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Sep,max T Sep,september,degrees Celsius,*degree*C*, +temperature_max_10,temperature_max_10,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Oct,max T Oct,october,degrees Celsius,*degree*C*, +temperature_max_11,temperature_max_11,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Nov,max T Nov,november,degrees Celsius,*degree*C*, +temperature_max_12,temperature_max_12,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Dec,max T Dec,december,degrees Celsius,*degree*C*, +bio01,bio01,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual mean temperature,ann. mean T,year,degrees Celsius,*degree*C*, +bio02,bio02,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean diurnal range,diurn. range,year,degrees Celsius,*degree*C*, +bio03,bio03,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,isothermality,isothermality,year,,, +bio04,bio04,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature seasonality,T season.,year,degrees Celsius,*degree*C*, +bio05,bio05,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature of warmest month,max. T of warmest mo.,year,degrees Celsius,*degree*C*, +bio06,bio06,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature of coldest month,min. T of coldest mo.,year,degrees Celsius,*degree*C*, +bio07,bio07,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature annual range (bio05-bio06),T ann. Range,year,degrees Celsius,*degree*C*, +bio08,bio08,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of wettest quarter,mean T of wettest qtr,year,degrees Celsius,*degree*C*, +bio09,bio09,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of driest quarter,mean T of driest qtr,year,degrees Celsius,*degree*C*, +bio10,bio10,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of warmest quarter,mean T of warmest qtr,year,degrees Celsius,*degree*C*, +bio11,bio11,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of coldest quarter,mean T of coldest qtr,year,degrees Celsius,*degree*C*, +bio12,bio12,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual precipitation,ann. P,year,mm per year,*mm~yr^-1*, +bio13,bio13,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest month,P of wettest mo.,year,mm per month,*mm~mo^-1*, +bio14,bio14,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest month,P of driest mo.,year,mm per month,*mm~mo^-1*, +bio15,bio15,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation seasonality (coeff var),P season.,year,,, +bio16,bio16,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest quarter,P of wettest qtr,year,mm per quarter,*mm~qtr^-1*, +bio17,bio17,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest quarter,P of driest qtr,year,mm per quarter,*mm~qtr^-1*, +bio18,bio18,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of warmest quarter,P of warmest qtr,year,mm per quarter,*mm~qtr^-1*, +bio19,bio19,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of coldest quarter,P of coldest qtr,year,mm per quarter,*mm~qtr^-1*, +precipitation_01,precipitation_01,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jan,P Jan,january,mm per month,*mm~mo^-1*, +precipitation_02,precipitation_02,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Feb,P Feb,february,mm per month,*mm~mo^-1*, +precipitation_03,precipitation_03,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Mar,P Mar,march,mm per month,*mm~mo^-1*, +precipitation_04,precipitation_04,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Apr,P Apr,april,mm per month,*mm~mo^-1*, +precipitation_05,precipitation_05,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation May,P May,may,mm per month,*mm~mo^-1*, +precipitation_06,precipitation_06,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jun,P Jun,june,mm per month,*mm~mo^-1*, +precipitation_07,precipitation_07,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jul,P Jul,july,mm per month,*mm~mo^-1*, +precipitation_08,precipitation_08,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Aug,P Aug,august,mm per month,*mm~mo^-1*, +precipitation_09,precipitation_09,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Sep,P Sep,september,mm per month,*mm~mo^-1*, +precipitation_10,precipitation_10,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Oct,P Oct,october,mm per month,*mm~mo^-1*, +precipitation_11,precipitation_11,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Nov,P Nov,november,mm per month,*mm~mo^-1*, +precipitation_12,precipitation_12,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Dec,P Dec,december,mm per month,*mm~mo^-1*, +temperature_min_01,temperature_min_01,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jan,min T Jan,january,degrees Celsius,*degree*C*, +temperature_min_02,temperature_min_02,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Feb,min T Feb,february,degrees Celsius,*degree*C*, +temperature_min_03,temperature_min_03,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Mar,min T Mar,march,degrees Celsius,*degree*C*, +temperature_min_04,temperature_min_04,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Apr,min T Apr,april,degrees Celsius,*degree*C*, +temperature_min_05,temperature_min_05,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature May,min T May,may,degrees Celsius,*degree*C*, +temperature_min_06,temperature_min_06,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jun,min T Jun,june,degrees Celsius,*degree*C*, +temperature_min_07,temperature_min_07,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jul,min T Jul,july,degrees Celsius,*degree*C*, +temperature_min_08,temperature_min_08,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Aug,min T Aug,august,degrees Celsius,*degree*C*, +temperature_min_09,temperature_min_09,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Sep,min T Sep,september,degrees Celsius,*degree*C*, +temperature_min_10,temperature_min_10,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Oct,min T Oct,october,degrees Celsius,*degree*C*, +temperature_min_11,temperature_min_11,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Nov,min T Nov,november,degrees Celsius,*degree*C*, +temperature_min_12,temperature_min_12,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Dec,min T Dec,december,degrees Celsius,*degree*C*, +temperature_max_01,temperature_max_01,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jan,max T Jan,january,degrees Celsius,*degree*C*, +temperature_max_02,temperature_max_02,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Feb,max T Feb,february,degrees Celsius,*degree*C*, +temperature_max_03,temperature_max_03,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Mar,max T Mar,march,degrees Celsius,*degree*C*, +temperature_max_04,temperature_max_04,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Apr,max T Apr,april,degrees Celsius,*degree*C*, +temperature_max_05,temperature_max_05,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature May,max T May,may,degrees Celsius,*degree*C*, +temperature_max_06,temperature_max_06,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jun,max T Jun,june,degrees Celsius,*degree*C*, +temperature_max_07,temperature_max_07,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jul,max T Jul,july,degrees Celsius,*degree*C*, +temperature_max_08,temperature_max_08,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Aug,max T Aug,august,degrees Celsius,*degree*C*, +temperature_max_09,temperature_max_09,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Sep,max T Sep,september,degrees Celsius,*degree*C*, +temperature_max_10,temperature_max_10,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Oct,max T Oct,october,degrees Celsius,*degree*C*, +temperature_max_11,temperature_max_11,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Nov,max T Nov,november,degrees Celsius,*degree*C*, +temperature_max_12,temperature_max_12,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Dec,max T Dec,december,degrees Celsius,*degree*C*, +bio01,bio01,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual mean temperature,ann. mean T,year,degrees Celsius,*degree*C*, +bio02,bio02,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean diurnal range,diurn. range,year,degrees Celsius,*degree*C*, +bio03,bio03,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,isothermality,isothermality,year,,, +bio04,bio04,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature seasonality,T season.,year,degrees Celsius,*degree*C*, +bio05,bio05,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature of warmest month,max. T of warmest mo.,year,degrees Celsius,*degree*C*, +bio06,bio06,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature of coldest month,min. T of coldest mo.,year,degrees Celsius,*degree*C*, +bio07,bio07,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature annual range (bio05-bio06),T ann. Range,year,degrees Celsius,*degree*C*, +bio08,bio08,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of wettest quarter,mean T of wettest qtr,year,degrees Celsius,*degree*C*, +bio09,bio09,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of driest quarter,mean T of driest qtr,year,degrees Celsius,*degree*C*, +bio10,bio10,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of warmest quarter,mean T of warmest qtr,year,degrees Celsius,*degree*C*, +bio11,bio11,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of coldest quarter,mean T of coldest qtr,year,degrees Celsius,*degree*C*, +bio12,bio12,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual precipitation,ann. P,year,mm per year,*mm~yr^-1*, +bio13,bio13,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest month,P of wettest mo.,year,mm per month,*mm~mo^-1*, +bio14,bio14,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest month,P of driest mo.,year,mm per month,*mm~mo^-1*, +bio15,bio15,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation seasonality (coeff var),P season.,year,,, +bio16,bio16,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest quarter,P of wettest qtr,year,mm per quarter,*mm~qtr^-1*, +bio17,bio17,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest quarter,P of driest qtr,year,mm per quarter,*mm~qtr^-1*, +bio18,bio18,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of warmest quarter,P of warmest qtr,year,mm per quarter,*mm~qtr^-1*, +bio19,bio19,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of coldest quarter,P of coldest qtr,year,mm per quarter,*mm~qtr^-1*, +precipitation_01,precipitation_01,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jan,P Jan,january,mm per month,*mm~mo^-1*, +precipitation_02,precipitation_02,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Feb,P Feb,february,mm per month,*mm~mo^-1*, +precipitation_03,precipitation_03,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Mar,P Mar,march,mm per month,*mm~mo^-1*, +precipitation_04,precipitation_04,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Apr,P Apr,april,mm per month,*mm~mo^-1*, +precipitation_05,precipitation_05,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation May,P May,may,mm per month,*mm~mo^-1*, +precipitation_06,precipitation_06,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jun,P Jun,june,mm per month,*mm~mo^-1*, +precipitation_07,precipitation_07,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jul,P Jul,july,mm per month,*mm~mo^-1*, +precipitation_08,precipitation_08,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Aug,P Aug,august,mm per month,*mm~mo^-1*, +precipitation_09,precipitation_09,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Sep,P Sep,september,mm per month,*mm~mo^-1*, +precipitation_10,precipitation_10,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Oct,P Oct,october,mm per month,*mm~mo^-1*, +precipitation_11,precipitation_11,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Nov,P Nov,november,mm per month,*mm~mo^-1*, +precipitation_12,precipitation_12,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Dec,P Dec,december,mm per month,*mm~mo^-1*, +temperature_min_01,temperature_min_01,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jan,min T Jan,january,degrees Celsius,*degree*C*, +temperature_min_02,temperature_min_02,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Feb,min T Feb,february,degrees Celsius,*degree*C*, +temperature_min_03,temperature_min_03,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Mar,min T Mar,march,degrees Celsius,*degree*C*, +temperature_min_04,temperature_min_04,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Apr,min T Apr,april,degrees Celsius,*degree*C*, +temperature_min_05,temperature_min_05,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature May,min T May,may,degrees Celsius,*degree*C*, +temperature_min_06,temperature_min_06,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jun,min T Jun,june,degrees Celsius,*degree*C*, +temperature_min_07,temperature_min_07,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jul,min T Jul,july,degrees Celsius,*degree*C*, +temperature_min_08,temperature_min_08,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Aug,min T Aug,august,degrees Celsius,*degree*C*, +temperature_min_09,temperature_min_09,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Sep,min T Sep,september,degrees Celsius,*degree*C*, +temperature_min_10,temperature_min_10,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Oct,min T Oct,october,degrees Celsius,*degree*C*, +temperature_min_11,temperature_min_11,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Nov,min T Nov,november,degrees Celsius,*degree*C*, +temperature_min_12,temperature_min_12,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Dec,min T Dec,december,degrees Celsius,*degree*C*, +temperature_max_01,temperature_max_01,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jan,max T Jan,january,degrees Celsius,*degree*C*, +temperature_max_02,temperature_max_02,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Feb,max T Feb,february,degrees Celsius,*degree*C*, +temperature_max_03,temperature_max_03,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Mar,max T Mar,march,degrees Celsius,*degree*C*, +temperature_max_04,temperature_max_04,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Apr,max T Apr,april,degrees Celsius,*degree*C*, +temperature_max_05,temperature_max_05,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature May,max T May,may,degrees Celsius,*degree*C*, +temperature_max_06,temperature_max_06,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jun,max T Jun,june,degrees Celsius,*degree*C*, +temperature_max_07,temperature_max_07,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jul,max T Jul,july,degrees Celsius,*degree*C*, +temperature_max_08,temperature_max_08,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Aug,max T Aug,august,degrees Celsius,*degree*C*, +temperature_max_09,temperature_max_09,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Sep,max T Sep,september,degrees Celsius,*degree*C*, +temperature_max_10,temperature_max_10,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Oct,max T Oct,october,degrees Celsius,*degree*C*, +temperature_max_11,temperature_max_11,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Nov,max T Nov,november,degrees Celsius,*degree*C*, +temperature_max_12,temperature_max_12,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Dec,max T Dec,december,degrees Celsius,*degree*C*, +bio01,bio01,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual mean temperature,ann. mean T,year,degrees Celsius,*degree*C*, +bio02,bio02,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean diurnal range,diurn. range,year,degrees Celsius,*degree*C*, +bio03,bio03,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,isothermality,isothermality,year,,, +bio04,bio04,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature seasonality,T season.,year,degrees Celsius,*degree*C*, +bio05,bio05,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature of warmest month,max. T of warmest mo.,year,degrees Celsius,*degree*C*, +bio06,bio06,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature of coldest month,min. T of coldest mo.,year,degrees Celsius,*degree*C*, +bio07,bio07,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature annual range (bio05-bio06),T ann. Range,year,degrees Celsius,*degree*C*, +bio08,bio08,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of wettest quarter,mean T of wettest qtr,year,degrees Celsius,*degree*C*, +bio09,bio09,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of driest quarter,mean T of driest qtr,year,degrees Celsius,*degree*C*, +bio10,bio10,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of warmest quarter,mean T of warmest qtr,year,degrees Celsius,*degree*C*, +bio11,bio11,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of coldest quarter,mean T of coldest qtr,year,degrees Celsius,*degree*C*, +bio12,bio12,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual precipitation,ann. P,year,mm per year,*mm~yr^-1*, +bio13,bio13,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest month,P of wettest mo.,year,mm per month,*mm~mo^-1*, +bio14,bio14,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest month,P of driest mo.,year,mm per month,*mm~mo^-1*, +bio15,bio15,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation seasonality (coeff var),P season.,year,,, +bio16,bio16,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest quarter,P of wettest qtr,year,mm per quarter,*mm~qtr^-1*, +bio17,bio17,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest quarter,P of driest qtr,year,mm per quarter,*mm~qtr^-1*, +bio18,bio18,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of warmest quarter,P of warmest qtr,year,mm per quarter,*mm~qtr^-1*, +bio19,bio19,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of coldest quarter,P of coldest qtr,year,mm per quarter,*mm~qtr^-1*, +precipitation_01,precipitation_01,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jan,P Jan,january,mm per month,*mm~mo^-1*, +precipitation_02,precipitation_02,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Feb,P Feb,february,mm per month,*mm~mo^-1*, +precipitation_03,precipitation_03,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Mar,P Mar,march,mm per month,*mm~mo^-1*, +precipitation_04,precipitation_04,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Apr,P Apr,april,mm per month,*mm~mo^-1*, +precipitation_05,precipitation_05,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation May,P May,may,mm per month,*mm~mo^-1*, +precipitation_06,precipitation_06,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jun,P Jun,june,mm per month,*mm~mo^-1*, +precipitation_07,precipitation_07,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jul,P Jul,july,mm per month,*mm~mo^-1*, +precipitation_08,precipitation_08,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Aug,P Aug,august,mm per month,*mm~mo^-1*, +precipitation_09,precipitation_09,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Sep,P Sep,september,mm per month,*mm~mo^-1*, +precipitation_10,precipitation_10,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Oct,P Oct,october,mm per month,*mm~mo^-1*, +precipitation_11,precipitation_11,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Nov,P Nov,november,mm per month,*mm~mo^-1*, +precipitation_12,precipitation_12,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Dec,P Dec,december,mm per month,*mm~mo^-1*, +temperature_min_01,temperature_min_01,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jan,min T Jan,january,degrees Celsius,*degree*C*, +temperature_min_02,temperature_min_02,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Feb,min T Feb,february,degrees Celsius,*degree*C*, +temperature_min_03,temperature_min_03,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Mar,min T Mar,march,degrees Celsius,*degree*C*, +temperature_min_04,temperature_min_04,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Apr,min T Apr,april,degrees Celsius,*degree*C*, +temperature_min_05,temperature_min_05,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature May,min T May,may,degrees Celsius,*degree*C*, +temperature_min_06,temperature_min_06,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jun,min T Jun,june,degrees Celsius,*degree*C*, +temperature_min_07,temperature_min_07,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jul,min T Jul,july,degrees Celsius,*degree*C*, +temperature_min_08,temperature_min_08,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Aug,min T Aug,august,degrees Celsius,*degree*C*, +temperature_min_09,temperature_min_09,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Sep,min T Sep,september,degrees Celsius,*degree*C*, +temperature_min_10,temperature_min_10,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Oct,min T Oct,october,degrees Celsius,*degree*C*, +temperature_min_11,temperature_min_11,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Nov,min T Nov,november,degrees Celsius,*degree*C*, +temperature_min_12,temperature_min_12,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Dec,min T Dec,december,degrees Celsius,*degree*C*, +temperature_max_01,temperature_max_01,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jan,max T Jan,january,degrees Celsius,*degree*C*, +temperature_max_02,temperature_max_02,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Feb,max T Feb,february,degrees Celsius,*degree*C*, +temperature_max_03,temperature_max_03,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Mar,max T Mar,march,degrees Celsius,*degree*C*, +temperature_max_04,temperature_max_04,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Apr,max T Apr,april,degrees Celsius,*degree*C*, +temperature_max_05,temperature_max_05,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature May,max T May,may,degrees Celsius,*degree*C*, +temperature_max_06,temperature_max_06,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jun,max T Jun,june,degrees Celsius,*degree*C*, +temperature_max_07,temperature_max_07,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jul,max T Jul,july,degrees Celsius,*degree*C*, +temperature_max_08,temperature_max_08,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Aug,max T Aug,august,degrees Celsius,*degree*C*, +temperature_max_09,temperature_max_09,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Sep,max T Sep,september,degrees Celsius,*degree*C*, +temperature_max_10,temperature_max_10,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Oct,max T Oct,october,degrees Celsius,*degree*C*, +temperature_max_11,temperature_max_11,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Nov,max T Nov,november,degrees Celsius,*degree*C*, +temperature_max_12,temperature_max_12,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Dec,max T Dec,december,degrees Celsius,*degree*C*, +bio01,bio01,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual mean temperature,ann. mean T,year,degrees Celsius,*degree*C*, +bio02,bio02,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean diurnal range,diurn. range,year,degrees Celsius,*degree*C*, +bio03,bio03,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,isothermality,isothermality,year,,, +bio04,bio04,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature seasonality,T season.,year,degrees Celsius,*degree*C*, +bio05,bio05,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature of warmest month,max. T of warmest mo.,year,degrees Celsius,*degree*C*, +bio06,bio06,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature of coldest month,min. T of coldest mo.,year,degrees Celsius,*degree*C*, +bio07,bio07,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature annual range (bio05-bio06),T ann. Range,year,degrees Celsius,*degree*C*, +bio08,bio08,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of wettest quarter,mean T of wettest qtr,year,degrees Celsius,*degree*C*, +bio09,bio09,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of driest quarter,mean T of driest qtr,year,degrees Celsius,*degree*C*, +bio10,bio10,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of warmest quarter,mean T of warmest qtr,year,degrees Celsius,*degree*C*, +bio11,bio11,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of coldest quarter,mean T of coldest qtr,year,degrees Celsius,*degree*C*, +bio12,bio12,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual precipitation,ann. P,year,mm per year,*mm~yr^-1*, +bio13,bio13,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest month,P of wettest mo.,year,mm per month,*mm~mo^-1*, +bio14,bio14,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest month,P of driest mo.,year,mm per month,*mm~mo^-1*, +bio15,bio15,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation seasonality (coeff var),P season.,year,,, +bio16,bio16,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest quarter,P of wettest qtr,year,mm per quarter,*mm~qtr^-1*, +bio17,bio17,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest quarter,P of driest qtr,year,mm per quarter,*mm~qtr^-1*, +bio18,bio18,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of warmest quarter,P of warmest qtr,year,mm per quarter,*mm~qtr^-1*, +bio19,bio19,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of coldest quarter,P of coldest qtr,year,mm per quarter,*mm~qtr^-1*, +precipitation_01,precipitation_01,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jan,P Jan,january,mm per month,*mm~mo^-1*, +precipitation_02,precipitation_02,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Feb,P Feb,february,mm per month,*mm~mo^-1*, +precipitation_03,precipitation_03,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Mar,P Mar,march,mm per month,*mm~mo^-1*, +precipitation_04,precipitation_04,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Apr,P Apr,april,mm per month,*mm~mo^-1*, +precipitation_05,precipitation_05,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation May,P May,may,mm per month,*mm~mo^-1*, +precipitation_06,precipitation_06,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jun,P Jun,june,mm per month,*mm~mo^-1*, +precipitation_07,precipitation_07,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jul,P Jul,july,mm per month,*mm~mo^-1*, +precipitation_08,precipitation_08,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Aug,P Aug,august,mm per month,*mm~mo^-1*, +precipitation_09,precipitation_09,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Sep,P Sep,september,mm per month,*mm~mo^-1*, +precipitation_10,precipitation_10,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Oct,P Oct,october,mm per month,*mm~mo^-1*, +precipitation_11,precipitation_11,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Nov,P Nov,november,mm per month,*mm~mo^-1*, +precipitation_12,precipitation_12,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Dec,P Dec,december,mm per month,*mm~mo^-1*, +temperature_min_01,temperature_min_01,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jan,min T Jan,january,degrees Celsius,*degree*C*, +temperature_min_02,temperature_min_02,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Feb,min T Feb,february,degrees Celsius,*degree*C*, +temperature_min_03,temperature_min_03,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Mar,min T Mar,march,degrees Celsius,*degree*C*, +temperature_min_04,temperature_min_04,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Apr,min T Apr,april,degrees Celsius,*degree*C*, +temperature_min_05,temperature_min_05,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature May,min T May,may,degrees Celsius,*degree*C*, +temperature_min_06,temperature_min_06,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jun,min T Jun,june,degrees Celsius,*degree*C*, +temperature_min_07,temperature_min_07,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jul,min T Jul,july,degrees Celsius,*degree*C*, +temperature_min_08,temperature_min_08,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Aug,min T Aug,august,degrees Celsius,*degree*C*, +temperature_min_09,temperature_min_09,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Sep,min T Sep,september,degrees Celsius,*degree*C*, +temperature_min_10,temperature_min_10,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Oct,min T Oct,october,degrees Celsius,*degree*C*, +temperature_min_11,temperature_min_11,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Nov,min T Nov,november,degrees Celsius,*degree*C*, +temperature_min_12,temperature_min_12,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Dec,min T Dec,december,degrees Celsius,*degree*C*, +temperature_max_01,temperature_max_01,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jan,max T Jan,january,degrees Celsius,*degree*C*, +temperature_max_02,temperature_max_02,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Feb,max T Feb,february,degrees Celsius,*degree*C*, +temperature_max_03,temperature_max_03,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Mar,max T Mar,march,degrees Celsius,*degree*C*, +temperature_max_04,temperature_max_04,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Apr,max T Apr,april,degrees Celsius,*degree*C*, +temperature_max_05,temperature_max_05,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature May,max T May,may,degrees Celsius,*degree*C*, +temperature_max_06,temperature_max_06,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jun,max T Jun,june,degrees Celsius,*degree*C*, +temperature_max_07,temperature_max_07,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jul,max T Jul,july,degrees Celsius,*degree*C*, +temperature_max_08,temperature_max_08,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Aug,max T Aug,august,degrees Celsius,*degree*C*, +temperature_max_09,temperature_max_09,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Sep,max T Sep,september,degrees Celsius,*degree*C*, +temperature_max_10,temperature_max_10,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Oct,max T Oct,october,degrees Celsius,*degree*C*, +temperature_max_11,temperature_max_11,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Nov,max T Nov,november,degrees Celsius,*degree*C*, +temperature_max_12,temperature_max_12,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Dec,max T Dec,december,degrees Celsius,*degree*C*, +bio01,bio01,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual mean temperature,ann. mean T,year,degrees Celsius,*degree*C*, +bio02,bio02,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean diurnal range,diurn. range,year,degrees Celsius,*degree*C*, +bio03,bio03,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,isothermality,isothermality,year,,, +bio04,bio04,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature seasonality,T season.,year,degrees Celsius,*degree*C*, +bio05,bio05,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature of warmest month,max. T of warmest mo.,year,degrees Celsius,*degree*C*, +bio06,bio06,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature of coldest month,min. T of coldest mo.,year,degrees Celsius,*degree*C*, +bio07,bio07,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature annual range (bio05-bio06),T ann. Range,year,degrees Celsius,*degree*C*, +bio08,bio08,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of wettest quarter,mean T of wettest qtr,year,degrees Celsius,*degree*C*, +bio09,bio09,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of driest quarter,mean T of driest qtr,year,degrees Celsius,*degree*C*, +bio10,bio10,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of warmest quarter,mean T of warmest qtr,year,degrees Celsius,*degree*C*, +bio11,bio11,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of coldest quarter,mean T of coldest qtr,year,degrees Celsius,*degree*C*, +bio12,bio12,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual precipitation,ann. P,year,mm per year,*mm~yr^-1*, +bio13,bio13,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest month,P of wettest mo.,year,mm per month,*mm~mo^-1*, +bio14,bio14,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest month,P of driest mo.,year,mm per month,*mm~mo^-1*, +bio15,bio15,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation seasonality (coeff var),P season.,year,,, +bio16,bio16,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest quarter,P of wettest qtr,year,mm per quarter,*mm~qtr^-1*, +bio17,bio17,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest quarter,P of driest qtr,year,mm per quarter,*mm~qtr^-1*, +bio18,bio18,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of warmest quarter,P of warmest qtr,year,mm per quarter,*mm~qtr^-1*, +bio19,bio19,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of coldest quarter,P of coldest qtr,year,mm per quarter,*mm~qtr^-1*, +precipitation_01,precipitation_01,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jan,P Jan,january,mm per month,*mm~mo^-1*, +precipitation_02,precipitation_02,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Feb,P Feb,february,mm per month,*mm~mo^-1*, +precipitation_03,precipitation_03,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Mar,P Mar,march,mm per month,*mm~mo^-1*, +precipitation_04,precipitation_04,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Apr,P Apr,april,mm per month,*mm~mo^-1*, +precipitation_05,precipitation_05,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation May,P May,may,mm per month,*mm~mo^-1*, +precipitation_06,precipitation_06,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jun,P Jun,june,mm per month,*mm~mo^-1*, +precipitation_07,precipitation_07,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jul,P Jul,july,mm per month,*mm~mo^-1*, +precipitation_08,precipitation_08,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Aug,P Aug,august,mm per month,*mm~mo^-1*, +precipitation_09,precipitation_09,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Sep,P Sep,september,mm per month,*mm~mo^-1*, +precipitation_10,precipitation_10,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Oct,P Oct,october,mm per month,*mm~mo^-1*, +precipitation_11,precipitation_11,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Nov,P Nov,november,mm per month,*mm~mo^-1*, +precipitation_12,precipitation_12,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Dec,P Dec,december,mm per month,*mm~mo^-1*, +temperature_min_01,temperature_min_01,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jan,min T Jan,january,degrees Celsius,*degree*C*, +temperature_min_02,temperature_min_02,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Feb,min T Feb,february,degrees Celsius,*degree*C*, +temperature_min_03,temperature_min_03,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Mar,min T Mar,march,degrees Celsius,*degree*C*, +temperature_min_04,temperature_min_04,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Apr,min T Apr,april,degrees Celsius,*degree*C*, +temperature_min_05,temperature_min_05,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature May,min T May,may,degrees Celsius,*degree*C*, +temperature_min_06,temperature_min_06,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jun,min T Jun,june,degrees Celsius,*degree*C*, +temperature_min_07,temperature_min_07,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jul,min T Jul,july,degrees Celsius,*degree*C*, +temperature_min_08,temperature_min_08,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Aug,min T Aug,august,degrees Celsius,*degree*C*, +temperature_min_09,temperature_min_09,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Sep,min T Sep,september,degrees Celsius,*degree*C*, +temperature_min_10,temperature_min_10,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Oct,min T Oct,october,degrees Celsius,*degree*C*, +temperature_min_11,temperature_min_11,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Nov,min T Nov,november,degrees Celsius,*degree*C*, +temperature_min_12,temperature_min_12,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Dec,min T Dec,december,degrees Celsius,*degree*C*, +temperature_max_01,temperature_max_01,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jan,max T Jan,january,degrees Celsius,*degree*C*, +temperature_max_02,temperature_max_02,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Feb,max T Feb,february,degrees Celsius,*degree*C*, +temperature_max_03,temperature_max_03,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Mar,max T Mar,march,degrees Celsius,*degree*C*, +temperature_max_04,temperature_max_04,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Apr,max T Apr,april,degrees Celsius,*degree*C*, +temperature_max_05,temperature_max_05,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature May,max T May,may,degrees Celsius,*degree*C*, +temperature_max_06,temperature_max_06,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jun,max T Jun,june,degrees Celsius,*degree*C*, +temperature_max_07,temperature_max_07,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jul,max T Jul,july,degrees Celsius,*degree*C*, +temperature_max_08,temperature_max_08,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Aug,max T Aug,august,degrees Celsius,*degree*C*, +temperature_max_09,temperature_max_09,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Sep,max T Sep,september,degrees Celsius,*degree*C*, +temperature_max_10,temperature_max_10,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Oct,max T Oct,october,degrees Celsius,*degree*C*, +temperature_max_11,temperature_max_11,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Nov,max T Nov,november,degrees Celsius,*degree*C*, +temperature_max_12,temperature_max_12,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Dec,max T Dec,december,degrees Celsius,*degree*C*, +bio01,bio01,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual mean temperature,ann. mean T,year,degrees Celsius,*degree*C*, +bio02,bio02,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean diurnal range,diurn. range,year,degrees Celsius,*degree*C*, +bio03,bio03,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,isothermality,isothermality,year,,, +bio04,bio04,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature seasonality,T season.,year,degrees Celsius,*degree*C*, +bio05,bio05,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature of warmest month,max. T of warmest mo.,year,degrees Celsius,*degree*C*, +bio06,bio06,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature of coldest month,min. T of coldest mo.,year,degrees Celsius,*degree*C*, +bio07,bio07,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature annual range (bio05-bio06),T ann. Range,year,degrees Celsius,*degree*C*, +bio08,bio08,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of wettest quarter,mean T of wettest qtr,year,degrees Celsius,*degree*C*, +bio09,bio09,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of driest quarter,mean T of driest qtr,year,degrees Celsius,*degree*C*, +bio10,bio10,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of warmest quarter,mean T of warmest qtr,year,degrees Celsius,*degree*C*, +bio11,bio11,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of coldest quarter,mean T of coldest qtr,year,degrees Celsius,*degree*C*, +bio12,bio12,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual precipitation,ann. P,year,mm per year,*mm~yr^-1*, +bio13,bio13,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest month,P of wettest mo.,year,mm per month,*mm~mo^-1*, +bio14,bio14,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest month,P of driest mo.,year,mm per month,*mm~mo^-1*, +bio15,bio15,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation seasonality (coeff var),P season.,year,,, +bio16,bio16,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest quarter,P of wettest qtr,year,mm per quarter,*mm~qtr^-1*, +bio17,bio17,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest quarter,P of driest qtr,year,mm per quarter,*mm~qtr^-1*, +bio18,bio18,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of warmest quarter,P of warmest qtr,year,mm per quarter,*mm~qtr^-1*, +bio19,bio19,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of coldest quarter,P of coldest qtr,year,mm per quarter,*mm~qtr^-1*, +precipitation_01,precipitation_01,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jan,P Jan,january,mm per month,*mm~mo^-1*, +precipitation_02,precipitation_02,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Feb,P Feb,february,mm per month,*mm~mo^-1*, +precipitation_03,precipitation_03,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Mar,P Mar,march,mm per month,*mm~mo^-1*, +precipitation_04,precipitation_04,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Apr,P Apr,april,mm per month,*mm~mo^-1*, +precipitation_05,precipitation_05,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation May,P May,may,mm per month,*mm~mo^-1*, +precipitation_06,precipitation_06,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jun,P Jun,june,mm per month,*mm~mo^-1*, +precipitation_07,precipitation_07,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jul,P Jul,july,mm per month,*mm~mo^-1*, +precipitation_08,precipitation_08,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Aug,P Aug,august,mm per month,*mm~mo^-1*, +precipitation_09,precipitation_09,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Sep,P Sep,september,mm per month,*mm~mo^-1*, +precipitation_10,precipitation_10,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Oct,P Oct,october,mm per month,*mm~mo^-1*, +precipitation_11,precipitation_11,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Nov,P Nov,november,mm per month,*mm~mo^-1*, +precipitation_12,precipitation_12,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Dec,P Dec,december,mm per month,*mm~mo^-1*, +temperature_min_01,temperature_min_01,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jan,min T Jan,january,degrees Celsius,*degree*C*, +temperature_min_02,temperature_min_02,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Feb,min T Feb,february,degrees Celsius,*degree*C*, +temperature_min_03,temperature_min_03,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Mar,min T Mar,march,degrees Celsius,*degree*C*, +temperature_min_04,temperature_min_04,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Apr,min T Apr,april,degrees Celsius,*degree*C*, +temperature_min_05,temperature_min_05,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature May,min T May,may,degrees Celsius,*degree*C*, +temperature_min_06,temperature_min_06,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jun,min T Jun,june,degrees Celsius,*degree*C*, +temperature_min_07,temperature_min_07,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jul,min T Jul,july,degrees Celsius,*degree*C*, +temperature_min_08,temperature_min_08,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Aug,min T Aug,august,degrees Celsius,*degree*C*, +temperature_min_09,temperature_min_09,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Sep,min T Sep,september,degrees Celsius,*degree*C*, +temperature_min_10,temperature_min_10,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Oct,min T Oct,october,degrees Celsius,*degree*C*, +temperature_min_11,temperature_min_11,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Nov,min T Nov,november,degrees Celsius,*degree*C*, +temperature_min_12,temperature_min_12,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Dec,min T Dec,december,degrees Celsius,*degree*C*, +temperature_max_01,temperature_max_01,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jan,max T Jan,january,degrees Celsius,*degree*C*, +temperature_max_02,temperature_max_02,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Feb,max T Feb,february,degrees Celsius,*degree*C*, +temperature_max_03,temperature_max_03,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Mar,max T Mar,march,degrees Celsius,*degree*C*, +temperature_max_04,temperature_max_04,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Apr,max T Apr,april,degrees Celsius,*degree*C*, +temperature_max_05,temperature_max_05,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature May,max T May,may,degrees Celsius,*degree*C*, +temperature_max_06,temperature_max_06,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jun,max T Jun,june,degrees Celsius,*degree*C*, +temperature_max_07,temperature_max_07,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jul,max T Jul,july,degrees Celsius,*degree*C*, +temperature_max_08,temperature_max_08,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Aug,max T Aug,august,degrees Celsius,*degree*C*, +temperature_max_09,temperature_max_09,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Sep,max T Sep,september,degrees Celsius,*degree*C*, +temperature_max_10,temperature_max_10,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Oct,max T Oct,october,degrees Celsius,*degree*C*, +temperature_max_11,temperature_max_11,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Nov,max T Nov,november,degrees Celsius,*degree*C*, +temperature_max_12,temperature_max_12,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Dec,max T Dec,december,degrees Celsius,*degree*C*, +bio01,bio01,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual mean temperature,ann. mean T,year,degrees Celsius,*degree*C*, +bio02,bio02,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean diurnal range,diurn. range,year,degrees Celsius,*degree*C*, +bio03,bio03,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,isothermality,isothermality,year,,, +bio04,bio04,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature seasonality,T season.,year,degrees Celsius,*degree*C*, +bio05,bio05,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature of warmest month,max. T of warmest mo.,year,degrees Celsius,*degree*C*, +bio06,bio06,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature of coldest month,min. T of coldest mo.,year,degrees Celsius,*degree*C*, +bio07,bio07,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature annual range (bio05-bio06),T ann. Range,year,degrees Celsius,*degree*C*, +bio08,bio08,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of wettest quarter,mean T of wettest qtr,year,degrees Celsius,*degree*C*, +bio09,bio09,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of driest quarter,mean T of driest qtr,year,degrees Celsius,*degree*C*, +bio10,bio10,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of warmest quarter,mean T of warmest qtr,year,degrees Celsius,*degree*C*, +bio11,bio11,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of coldest quarter,mean T of coldest qtr,year,degrees Celsius,*degree*C*, +bio12,bio12,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual precipitation,ann. P,year,mm per year,*mm~yr^-1*, +bio13,bio13,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest month,P of wettest mo.,year,mm per month,*mm~mo^-1*, +bio14,bio14,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest month,P of driest mo.,year,mm per month,*mm~mo^-1*, +bio15,bio15,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation seasonality (coeff var),P season.,year,,, +bio16,bio16,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest quarter,P of wettest qtr,year,mm per quarter,*mm~qtr^-1*, +bio17,bio17,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest quarter,P of driest qtr,year,mm per quarter,*mm~qtr^-1*, +bio18,bio18,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of warmest quarter,P of warmest qtr,year,mm per quarter,*mm~qtr^-1*, +bio19,bio19,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m,FALSE,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of coldest quarter,P of coldest qtr,year,mm per quarter,*mm~qtr^-1*, +precipitation_01,precipitation_01,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jan,P Jan,january,mm per month,*mm~mo^-1*, +precipitation_02,precipitation_02,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Feb,P Feb,february,mm per month,*mm~mo^-1*, +precipitation_03,precipitation_03,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Mar,P Mar,march,mm per month,*mm~mo^-1*, +precipitation_04,precipitation_04,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Apr,P Apr,april,mm per month,*mm~mo^-1*, +precipitation_05,precipitation_05,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation May,P May,may,mm per month,*mm~mo^-1*, +precipitation_06,precipitation_06,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jun,P Jun,june,mm per month,*mm~mo^-1*, +precipitation_07,precipitation_07,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jul,P Jul,july,mm per month,*mm~mo^-1*, +precipitation_08,precipitation_08,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Aug,P Aug,august,mm per month,*mm~mo^-1*, +precipitation_09,precipitation_09,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Sep,P Sep,september,mm per month,*mm~mo^-1*, +precipitation_10,precipitation_10,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Oct,P Oct,october,mm per month,*mm~mo^-1*, +precipitation_11,precipitation_11,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Nov,P Nov,november,mm per month,*mm~mo^-1*, +precipitation_12,precipitation_12,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Dec,P Dec,december,mm per month,*mm~mo^-1*, +temperature_min_01,temperature_min_01,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jan,min T Jan,january,degrees Celsius,*degree*C*, +temperature_min_02,temperature_min_02,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Feb,min T Feb,february,degrees Celsius,*degree*C*, +temperature_min_03,temperature_min_03,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Mar,min T Mar,march,degrees Celsius,*degree*C*, +temperature_min_04,temperature_min_04,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Apr,min T Apr,april,degrees Celsius,*degree*C*, +temperature_min_05,temperature_min_05,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature May,min T May,may,degrees Celsius,*degree*C*, +temperature_min_06,temperature_min_06,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jun,min T Jun,june,degrees Celsius,*degree*C*, +temperature_min_07,temperature_min_07,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jul,min T Jul,july,degrees Celsius,*degree*C*, +temperature_min_08,temperature_min_08,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Aug,min T Aug,august,degrees Celsius,*degree*C*, +temperature_min_09,temperature_min_09,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Sep,min T Sep,september,degrees Celsius,*degree*C*, +temperature_min_10,temperature_min_10,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Oct,min T Oct,october,degrees Celsius,*degree*C*, +temperature_min_11,temperature_min_11,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Nov,min T Nov,november,degrees Celsius,*degree*C*, +temperature_min_12,temperature_min_12,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Dec,min T Dec,december,degrees Celsius,*degree*C*, +temperature_max_01,temperature_max_01,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jan,max T Jan,january,degrees Celsius,*degree*C*, +temperature_max_02,temperature_max_02,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Feb,max T Feb,february,degrees Celsius,*degree*C*, +temperature_max_03,temperature_max_03,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Mar,max T Mar,march,degrees Celsius,*degree*C*, +temperature_max_04,temperature_max_04,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Apr,max T Apr,april,degrees Celsius,*degree*C*, +temperature_max_05,temperature_max_05,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature May,max T May,may,degrees Celsius,*degree*C*, +temperature_max_06,temperature_max_06,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jun,max T Jun,june,degrees Celsius,*degree*C*, +temperature_max_07,temperature_max_07,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jul,max T Jul,july,degrees Celsius,*degree*C*, +temperature_max_08,temperature_max_08,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Aug,max T Aug,august,degrees Celsius,*degree*C*, +temperature_max_09,temperature_max_09,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Sep,max T Sep,september,degrees Celsius,*degree*C*, +temperature_max_10,temperature_max_10,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Oct,max T Oct,october,degrees Celsius,*degree*C*, +temperature_max_11,temperature_max_11,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Nov,max T Nov,november,degrees Celsius,*degree*C*, +temperature_max_12,temperature_max_12,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m,TRUE,WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Dec,max T Dec,december,degrees Celsius,*degree*C*, +bio01,bio01,WorldClim_2.1_INM-CM5-0_ssp126_10m,FALSE,WorldClim_2.1_INM-CM5-0_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual mean temperature,ann. mean T,year,degrees Celsius,*degree*C*, +bio02,bio02,WorldClim_2.1_INM-CM5-0_ssp126_10m,FALSE,WorldClim_2.1_INM-CM5-0_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean diurnal range,diurn. range,year,degrees Celsius,*degree*C*, +bio03,bio03,WorldClim_2.1_INM-CM5-0_ssp126_10m,FALSE,WorldClim_2.1_INM-CM5-0_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,isothermality,isothermality,year,,, +bio04,bio04,WorldClim_2.1_INM-CM5-0_ssp126_10m,FALSE,WorldClim_2.1_INM-CM5-0_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature seasonality,T season.,year,degrees Celsius,*degree*C*, +bio05,bio05,WorldClim_2.1_INM-CM5-0_ssp126_10m,FALSE,WorldClim_2.1_INM-CM5-0_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature of warmest month,max. T of warmest mo.,year,degrees Celsius,*degree*C*, +bio06,bio06,WorldClim_2.1_INM-CM5-0_ssp126_10m,FALSE,WorldClim_2.1_INM-CM5-0_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature of coldest month,min. T of coldest mo.,year,degrees Celsius,*degree*C*, +bio07,bio07,WorldClim_2.1_INM-CM5-0_ssp126_10m,FALSE,WorldClim_2.1_INM-CM5-0_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature annual range (bio05-bio06),T ann. Range,year,degrees Celsius,*degree*C*, +bio08,bio08,WorldClim_2.1_INM-CM5-0_ssp126_10m,FALSE,WorldClim_2.1_INM-CM5-0_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of wettest quarter,mean T of wettest qtr,year,degrees Celsius,*degree*C*, +bio09,bio09,WorldClim_2.1_INM-CM5-0_ssp126_10m,FALSE,WorldClim_2.1_INM-CM5-0_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of driest quarter,mean T of driest qtr,year,degrees Celsius,*degree*C*, +bio10,bio10,WorldClim_2.1_INM-CM5-0_ssp126_10m,FALSE,WorldClim_2.1_INM-CM5-0_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of warmest quarter,mean T of warmest qtr,year,degrees Celsius,*degree*C*, +bio11,bio11,WorldClim_2.1_INM-CM5-0_ssp126_10m,FALSE,WorldClim_2.1_INM-CM5-0_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of coldest quarter,mean T of coldest qtr,year,degrees Celsius,*degree*C*, +bio12,bio12,WorldClim_2.1_INM-CM5-0_ssp126_10m,FALSE,WorldClim_2.1_INM-CM5-0_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual precipitation,ann. P,year,mm per year,*mm~yr^-1*, +bio13,bio13,WorldClim_2.1_INM-CM5-0_ssp126_10m,FALSE,WorldClim_2.1_INM-CM5-0_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest month,P of wettest mo.,year,mm per month,*mm~mo^-1*, +bio14,bio14,WorldClim_2.1_INM-CM5-0_ssp126_10m,FALSE,WorldClim_2.1_INM-CM5-0_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest month,P of driest mo.,year,mm per month,*mm~mo^-1*, +bio15,bio15,WorldClim_2.1_INM-CM5-0_ssp126_10m,FALSE,WorldClim_2.1_INM-CM5-0_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation seasonality (coeff var),P season.,year,,, +bio16,bio16,WorldClim_2.1_INM-CM5-0_ssp126_10m,FALSE,WorldClim_2.1_INM-CM5-0_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest quarter,P of wettest qtr,year,mm per quarter,*mm~qtr^-1*, +bio17,bio17,WorldClim_2.1_INM-CM5-0_ssp126_10m,FALSE,WorldClim_2.1_INM-CM5-0_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest quarter,P of driest qtr,year,mm per quarter,*mm~qtr^-1*, +bio18,bio18,WorldClim_2.1_INM-CM5-0_ssp126_10m,FALSE,WorldClim_2.1_INM-CM5-0_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of warmest quarter,P of warmest qtr,year,mm per quarter,*mm~qtr^-1*, +bio19,bio19,WorldClim_2.1_INM-CM5-0_ssp126_10m,FALSE,WorldClim_2.1_INM-CM5-0_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of coldest quarter,P of coldest qtr,year,mm per quarter,*mm~qtr^-1*, +precipitation_01,precipitation_01,WorldClim_2.1_INM-CM5-0_ssp126_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jan,P Jan,january,mm per month,*mm~mo^-1*, +precipitation_02,precipitation_02,WorldClim_2.1_INM-CM5-0_ssp126_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Feb,P Feb,february,mm per month,*mm~mo^-1*, +precipitation_03,precipitation_03,WorldClim_2.1_INM-CM5-0_ssp126_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Mar,P Mar,march,mm per month,*mm~mo^-1*, +precipitation_04,precipitation_04,WorldClim_2.1_INM-CM5-0_ssp126_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Apr,P Apr,april,mm per month,*mm~mo^-1*, +precipitation_05,precipitation_05,WorldClim_2.1_INM-CM5-0_ssp126_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation May,P May,may,mm per month,*mm~mo^-1*, +precipitation_06,precipitation_06,WorldClim_2.1_INM-CM5-0_ssp126_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jun,P Jun,june,mm per month,*mm~mo^-1*, +precipitation_07,precipitation_07,WorldClim_2.1_INM-CM5-0_ssp126_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jul,P Jul,july,mm per month,*mm~mo^-1*, +precipitation_08,precipitation_08,WorldClim_2.1_INM-CM5-0_ssp126_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Aug,P Aug,august,mm per month,*mm~mo^-1*, +precipitation_09,precipitation_09,WorldClim_2.1_INM-CM5-0_ssp126_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Sep,P Sep,september,mm per month,*mm~mo^-1*, +precipitation_10,precipitation_10,WorldClim_2.1_INM-CM5-0_ssp126_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Oct,P Oct,october,mm per month,*mm~mo^-1*, +precipitation_11,precipitation_11,WorldClim_2.1_INM-CM5-0_ssp126_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Nov,P Nov,november,mm per month,*mm~mo^-1*, +precipitation_12,precipitation_12,WorldClim_2.1_INM-CM5-0_ssp126_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Dec,P Dec,december,mm per month,*mm~mo^-1*, +temperature_min_01,temperature_min_01,WorldClim_2.1_INM-CM5-0_ssp126_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jan,min T Jan,january,degrees Celsius,*degree*C*, +temperature_min_02,temperature_min_02,WorldClim_2.1_INM-CM5-0_ssp126_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Feb,min T Feb,february,degrees Celsius,*degree*C*, +temperature_min_03,temperature_min_03,WorldClim_2.1_INM-CM5-0_ssp126_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Mar,min T Mar,march,degrees Celsius,*degree*C*, +temperature_min_04,temperature_min_04,WorldClim_2.1_INM-CM5-0_ssp126_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Apr,min T Apr,april,degrees Celsius,*degree*C*, +temperature_min_05,temperature_min_05,WorldClim_2.1_INM-CM5-0_ssp126_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature May,min T May,may,degrees Celsius,*degree*C*, +temperature_min_06,temperature_min_06,WorldClim_2.1_INM-CM5-0_ssp126_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jun,min T Jun,june,degrees Celsius,*degree*C*, +temperature_min_07,temperature_min_07,WorldClim_2.1_INM-CM5-0_ssp126_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jul,min T Jul,july,degrees Celsius,*degree*C*, +temperature_min_08,temperature_min_08,WorldClim_2.1_INM-CM5-0_ssp126_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Aug,min T Aug,august,degrees Celsius,*degree*C*, +temperature_min_09,temperature_min_09,WorldClim_2.1_INM-CM5-0_ssp126_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Sep,min T Sep,september,degrees Celsius,*degree*C*, +temperature_min_10,temperature_min_10,WorldClim_2.1_INM-CM5-0_ssp126_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Oct,min T Oct,october,degrees Celsius,*degree*C*, +temperature_min_11,temperature_min_11,WorldClim_2.1_INM-CM5-0_ssp126_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Nov,min T Nov,november,degrees Celsius,*degree*C*, +temperature_min_12,temperature_min_12,WorldClim_2.1_INM-CM5-0_ssp126_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Dec,min T Dec,december,degrees Celsius,*degree*C*, +temperature_max_01,temperature_max_01,WorldClim_2.1_INM-CM5-0_ssp126_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jan,max T Jan,january,degrees Celsius,*degree*C*, +temperature_max_02,temperature_max_02,WorldClim_2.1_INM-CM5-0_ssp126_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Feb,max T Feb,february,degrees Celsius,*degree*C*, +temperature_max_03,temperature_max_03,WorldClim_2.1_INM-CM5-0_ssp126_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Mar,max T Mar,march,degrees Celsius,*degree*C*, +temperature_max_04,temperature_max_04,WorldClim_2.1_INM-CM5-0_ssp126_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Apr,max T Apr,april,degrees Celsius,*degree*C*, +temperature_max_05,temperature_max_05,WorldClim_2.1_INM-CM5-0_ssp126_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature May,max T May,may,degrees Celsius,*degree*C*, +temperature_max_06,temperature_max_06,WorldClim_2.1_INM-CM5-0_ssp126_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jun,max T Jun,june,degrees Celsius,*degree*C*, +temperature_max_07,temperature_max_07,WorldClim_2.1_INM-CM5-0_ssp126_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jul,max T Jul,july,degrees Celsius,*degree*C*, +temperature_max_08,temperature_max_08,WorldClim_2.1_INM-CM5-0_ssp126_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Aug,max T Aug,august,degrees Celsius,*degree*C*, +temperature_max_09,temperature_max_09,WorldClim_2.1_INM-CM5-0_ssp126_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Sep,max T Sep,september,degrees Celsius,*degree*C*, +temperature_max_10,temperature_max_10,WorldClim_2.1_INM-CM5-0_ssp126_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Oct,max T Oct,october,degrees Celsius,*degree*C*, +temperature_max_11,temperature_max_11,WorldClim_2.1_INM-CM5-0_ssp126_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Nov,max T Nov,november,degrees Celsius,*degree*C*, +temperature_max_12,temperature_max_12,WorldClim_2.1_INM-CM5-0_ssp126_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Dec,max T Dec,december,degrees Celsius,*degree*C*, +bio01,bio01,WorldClim_2.1_INM-CM5-0_ssp126_5m,FALSE,WorldClim_2.1_INM-CM5-0_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual mean temperature,ann. mean T,year,degrees Celsius,*degree*C*, +bio02,bio02,WorldClim_2.1_INM-CM5-0_ssp126_5m,FALSE,WorldClim_2.1_INM-CM5-0_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean diurnal range,diurn. range,year,degrees Celsius,*degree*C*, +bio03,bio03,WorldClim_2.1_INM-CM5-0_ssp126_5m,FALSE,WorldClim_2.1_INM-CM5-0_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,isothermality,isothermality,year,,, +bio04,bio04,WorldClim_2.1_INM-CM5-0_ssp126_5m,FALSE,WorldClim_2.1_INM-CM5-0_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature seasonality,T season.,year,degrees Celsius,*degree*C*, +bio05,bio05,WorldClim_2.1_INM-CM5-0_ssp126_5m,FALSE,WorldClim_2.1_INM-CM5-0_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature of warmest month,max. T of warmest mo.,year,degrees Celsius,*degree*C*, +bio06,bio06,WorldClim_2.1_INM-CM5-0_ssp126_5m,FALSE,WorldClim_2.1_INM-CM5-0_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature of coldest month,min. T of coldest mo.,year,degrees Celsius,*degree*C*, +bio07,bio07,WorldClim_2.1_INM-CM5-0_ssp126_5m,FALSE,WorldClim_2.1_INM-CM5-0_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature annual range (bio05-bio06),T ann. Range,year,degrees Celsius,*degree*C*, +bio08,bio08,WorldClim_2.1_INM-CM5-0_ssp126_5m,FALSE,WorldClim_2.1_INM-CM5-0_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of wettest quarter,mean T of wettest qtr,year,degrees Celsius,*degree*C*, +bio09,bio09,WorldClim_2.1_INM-CM5-0_ssp126_5m,FALSE,WorldClim_2.1_INM-CM5-0_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of driest quarter,mean T of driest qtr,year,degrees Celsius,*degree*C*, +bio10,bio10,WorldClim_2.1_INM-CM5-0_ssp126_5m,FALSE,WorldClim_2.1_INM-CM5-0_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of warmest quarter,mean T of warmest qtr,year,degrees Celsius,*degree*C*, +bio11,bio11,WorldClim_2.1_INM-CM5-0_ssp126_5m,FALSE,WorldClim_2.1_INM-CM5-0_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of coldest quarter,mean T of coldest qtr,year,degrees Celsius,*degree*C*, +bio12,bio12,WorldClim_2.1_INM-CM5-0_ssp126_5m,FALSE,WorldClim_2.1_INM-CM5-0_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual precipitation,ann. P,year,mm per year,*mm~yr^-1*, +bio13,bio13,WorldClim_2.1_INM-CM5-0_ssp126_5m,FALSE,WorldClim_2.1_INM-CM5-0_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest month,P of wettest mo.,year,mm per month,*mm~mo^-1*, +bio14,bio14,WorldClim_2.1_INM-CM5-0_ssp126_5m,FALSE,WorldClim_2.1_INM-CM5-0_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest month,P of driest mo.,year,mm per month,*mm~mo^-1*, +bio15,bio15,WorldClim_2.1_INM-CM5-0_ssp126_5m,FALSE,WorldClim_2.1_INM-CM5-0_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation seasonality (coeff var),P season.,year,,, +bio16,bio16,WorldClim_2.1_INM-CM5-0_ssp126_5m,FALSE,WorldClim_2.1_INM-CM5-0_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest quarter,P of wettest qtr,year,mm per quarter,*mm~qtr^-1*, +bio17,bio17,WorldClim_2.1_INM-CM5-0_ssp126_5m,FALSE,WorldClim_2.1_INM-CM5-0_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest quarter,P of driest qtr,year,mm per quarter,*mm~qtr^-1*, +bio18,bio18,WorldClim_2.1_INM-CM5-0_ssp126_5m,FALSE,WorldClim_2.1_INM-CM5-0_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of warmest quarter,P of warmest qtr,year,mm per quarter,*mm~qtr^-1*, +bio19,bio19,WorldClim_2.1_INM-CM5-0_ssp126_5m,FALSE,WorldClim_2.1_INM-CM5-0_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of coldest quarter,P of coldest qtr,year,mm per quarter,*mm~qtr^-1*, +precipitation_01,precipitation_01,WorldClim_2.1_INM-CM5-0_ssp126_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jan,P Jan,january,mm per month,*mm~mo^-1*, +precipitation_02,precipitation_02,WorldClim_2.1_INM-CM5-0_ssp126_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Feb,P Feb,february,mm per month,*mm~mo^-1*, +precipitation_03,precipitation_03,WorldClim_2.1_INM-CM5-0_ssp126_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Mar,P Mar,march,mm per month,*mm~mo^-1*, +precipitation_04,precipitation_04,WorldClim_2.1_INM-CM5-0_ssp126_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Apr,P Apr,april,mm per month,*mm~mo^-1*, +precipitation_05,precipitation_05,WorldClim_2.1_INM-CM5-0_ssp126_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation May,P May,may,mm per month,*mm~mo^-1*, +precipitation_06,precipitation_06,WorldClim_2.1_INM-CM5-0_ssp126_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jun,P Jun,june,mm per month,*mm~mo^-1*, +precipitation_07,precipitation_07,WorldClim_2.1_INM-CM5-0_ssp126_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jul,P Jul,july,mm per month,*mm~mo^-1*, +precipitation_08,precipitation_08,WorldClim_2.1_INM-CM5-0_ssp126_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Aug,P Aug,august,mm per month,*mm~mo^-1*, +precipitation_09,precipitation_09,WorldClim_2.1_INM-CM5-0_ssp126_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Sep,P Sep,september,mm per month,*mm~mo^-1*, +precipitation_10,precipitation_10,WorldClim_2.1_INM-CM5-0_ssp126_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Oct,P Oct,october,mm per month,*mm~mo^-1*, +precipitation_11,precipitation_11,WorldClim_2.1_INM-CM5-0_ssp126_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Nov,P Nov,november,mm per month,*mm~mo^-1*, +precipitation_12,precipitation_12,WorldClim_2.1_INM-CM5-0_ssp126_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Dec,P Dec,december,mm per month,*mm~mo^-1*, +temperature_min_01,temperature_min_01,WorldClim_2.1_INM-CM5-0_ssp126_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jan,min T Jan,january,degrees Celsius,*degree*C*, +temperature_min_02,temperature_min_02,WorldClim_2.1_INM-CM5-0_ssp126_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Feb,min T Feb,february,degrees Celsius,*degree*C*, +temperature_min_03,temperature_min_03,WorldClim_2.1_INM-CM5-0_ssp126_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Mar,min T Mar,march,degrees Celsius,*degree*C*, +temperature_min_04,temperature_min_04,WorldClim_2.1_INM-CM5-0_ssp126_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Apr,min T Apr,april,degrees Celsius,*degree*C*, +temperature_min_05,temperature_min_05,WorldClim_2.1_INM-CM5-0_ssp126_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature May,min T May,may,degrees Celsius,*degree*C*, +temperature_min_06,temperature_min_06,WorldClim_2.1_INM-CM5-0_ssp126_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jun,min T Jun,june,degrees Celsius,*degree*C*, +temperature_min_07,temperature_min_07,WorldClim_2.1_INM-CM5-0_ssp126_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jul,min T Jul,july,degrees Celsius,*degree*C*, +temperature_min_08,temperature_min_08,WorldClim_2.1_INM-CM5-0_ssp126_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Aug,min T Aug,august,degrees Celsius,*degree*C*, +temperature_min_09,temperature_min_09,WorldClim_2.1_INM-CM5-0_ssp126_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Sep,min T Sep,september,degrees Celsius,*degree*C*, +temperature_min_10,temperature_min_10,WorldClim_2.1_INM-CM5-0_ssp126_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Oct,min T Oct,october,degrees Celsius,*degree*C*, +temperature_min_11,temperature_min_11,WorldClim_2.1_INM-CM5-0_ssp126_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Nov,min T Nov,november,degrees Celsius,*degree*C*, +temperature_min_12,temperature_min_12,WorldClim_2.1_INM-CM5-0_ssp126_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Dec,min T Dec,december,degrees Celsius,*degree*C*, +temperature_max_01,temperature_max_01,WorldClim_2.1_INM-CM5-0_ssp126_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jan,max T Jan,january,degrees Celsius,*degree*C*, +temperature_max_02,temperature_max_02,WorldClim_2.1_INM-CM5-0_ssp126_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Feb,max T Feb,february,degrees Celsius,*degree*C*, +temperature_max_03,temperature_max_03,WorldClim_2.1_INM-CM5-0_ssp126_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Mar,max T Mar,march,degrees Celsius,*degree*C*, +temperature_max_04,temperature_max_04,WorldClim_2.1_INM-CM5-0_ssp126_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Apr,max T Apr,april,degrees Celsius,*degree*C*, +temperature_max_05,temperature_max_05,WorldClim_2.1_INM-CM5-0_ssp126_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature May,max T May,may,degrees Celsius,*degree*C*, +temperature_max_06,temperature_max_06,WorldClim_2.1_INM-CM5-0_ssp126_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jun,max T Jun,june,degrees Celsius,*degree*C*, +temperature_max_07,temperature_max_07,WorldClim_2.1_INM-CM5-0_ssp126_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jul,max T Jul,july,degrees Celsius,*degree*C*, +temperature_max_08,temperature_max_08,WorldClim_2.1_INM-CM5-0_ssp126_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Aug,max T Aug,august,degrees Celsius,*degree*C*, +temperature_max_09,temperature_max_09,WorldClim_2.1_INM-CM5-0_ssp126_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Sep,max T Sep,september,degrees Celsius,*degree*C*, +temperature_max_10,temperature_max_10,WorldClim_2.1_INM-CM5-0_ssp126_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Oct,max T Oct,october,degrees Celsius,*degree*C*, +temperature_max_11,temperature_max_11,WorldClim_2.1_INM-CM5-0_ssp126_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Nov,max T Nov,november,degrees Celsius,*degree*C*, +temperature_max_12,temperature_max_12,WorldClim_2.1_INM-CM5-0_ssp126_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Dec,max T Dec,december,degrees Celsius,*degree*C*, +bio01,bio01,WorldClim_2.1_INM-CM5-0_ssp245_10m,FALSE,WorldClim_2.1_INM-CM5-0_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual mean temperature,ann. mean T,year,degrees Celsius,*degree*C*, +bio02,bio02,WorldClim_2.1_INM-CM5-0_ssp245_10m,FALSE,WorldClim_2.1_INM-CM5-0_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean diurnal range,diurn. range,year,degrees Celsius,*degree*C*, +bio03,bio03,WorldClim_2.1_INM-CM5-0_ssp245_10m,FALSE,WorldClim_2.1_INM-CM5-0_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,isothermality,isothermality,year,,, +bio04,bio04,WorldClim_2.1_INM-CM5-0_ssp245_10m,FALSE,WorldClim_2.1_INM-CM5-0_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature seasonality,T season.,year,degrees Celsius,*degree*C*, +bio05,bio05,WorldClim_2.1_INM-CM5-0_ssp245_10m,FALSE,WorldClim_2.1_INM-CM5-0_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature of warmest month,max. T of warmest mo.,year,degrees Celsius,*degree*C*, +bio06,bio06,WorldClim_2.1_INM-CM5-0_ssp245_10m,FALSE,WorldClim_2.1_INM-CM5-0_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature of coldest month,min. T of coldest mo.,year,degrees Celsius,*degree*C*, +bio07,bio07,WorldClim_2.1_INM-CM5-0_ssp245_10m,FALSE,WorldClim_2.1_INM-CM5-0_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature annual range (bio05-bio06),T ann. Range,year,degrees Celsius,*degree*C*, +bio08,bio08,WorldClim_2.1_INM-CM5-0_ssp245_10m,FALSE,WorldClim_2.1_INM-CM5-0_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of wettest quarter,mean T of wettest qtr,year,degrees Celsius,*degree*C*, +bio09,bio09,WorldClim_2.1_INM-CM5-0_ssp245_10m,FALSE,WorldClim_2.1_INM-CM5-0_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of driest quarter,mean T of driest qtr,year,degrees Celsius,*degree*C*, +bio10,bio10,WorldClim_2.1_INM-CM5-0_ssp245_10m,FALSE,WorldClim_2.1_INM-CM5-0_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of warmest quarter,mean T of warmest qtr,year,degrees Celsius,*degree*C*, +bio11,bio11,WorldClim_2.1_INM-CM5-0_ssp245_10m,FALSE,WorldClim_2.1_INM-CM5-0_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of coldest quarter,mean T of coldest qtr,year,degrees Celsius,*degree*C*, +bio12,bio12,WorldClim_2.1_INM-CM5-0_ssp245_10m,FALSE,WorldClim_2.1_INM-CM5-0_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual precipitation,ann. P,year,mm per year,*mm~yr^-1*, +bio13,bio13,WorldClim_2.1_INM-CM5-0_ssp245_10m,FALSE,WorldClim_2.1_INM-CM5-0_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest month,P of wettest mo.,year,mm per month,*mm~mo^-1*, +bio14,bio14,WorldClim_2.1_INM-CM5-0_ssp245_10m,FALSE,WorldClim_2.1_INM-CM5-0_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest month,P of driest mo.,year,mm per month,*mm~mo^-1*, +bio15,bio15,WorldClim_2.1_INM-CM5-0_ssp245_10m,FALSE,WorldClim_2.1_INM-CM5-0_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation seasonality (coeff var),P season.,year,,, +bio16,bio16,WorldClim_2.1_INM-CM5-0_ssp245_10m,FALSE,WorldClim_2.1_INM-CM5-0_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest quarter,P of wettest qtr,year,mm per quarter,*mm~qtr^-1*, +bio17,bio17,WorldClim_2.1_INM-CM5-0_ssp245_10m,FALSE,WorldClim_2.1_INM-CM5-0_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest quarter,P of driest qtr,year,mm per quarter,*mm~qtr^-1*, +bio18,bio18,WorldClim_2.1_INM-CM5-0_ssp245_10m,FALSE,WorldClim_2.1_INM-CM5-0_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of warmest quarter,P of warmest qtr,year,mm per quarter,*mm~qtr^-1*, +bio19,bio19,WorldClim_2.1_INM-CM5-0_ssp245_10m,FALSE,WorldClim_2.1_INM-CM5-0_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of coldest quarter,P of coldest qtr,year,mm per quarter,*mm~qtr^-1*, +precipitation_01,precipitation_01,WorldClim_2.1_INM-CM5-0_ssp245_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jan,P Jan,january,mm per month,*mm~mo^-1*, +precipitation_02,precipitation_02,WorldClim_2.1_INM-CM5-0_ssp245_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Feb,P Feb,february,mm per month,*mm~mo^-1*, +precipitation_03,precipitation_03,WorldClim_2.1_INM-CM5-0_ssp245_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Mar,P Mar,march,mm per month,*mm~mo^-1*, +precipitation_04,precipitation_04,WorldClim_2.1_INM-CM5-0_ssp245_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Apr,P Apr,april,mm per month,*mm~mo^-1*, +precipitation_05,precipitation_05,WorldClim_2.1_INM-CM5-0_ssp245_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation May,P May,may,mm per month,*mm~mo^-1*, +precipitation_06,precipitation_06,WorldClim_2.1_INM-CM5-0_ssp245_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jun,P Jun,june,mm per month,*mm~mo^-1*, +precipitation_07,precipitation_07,WorldClim_2.1_INM-CM5-0_ssp245_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jul,P Jul,july,mm per month,*mm~mo^-1*, +precipitation_08,precipitation_08,WorldClim_2.1_INM-CM5-0_ssp245_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Aug,P Aug,august,mm per month,*mm~mo^-1*, +precipitation_09,precipitation_09,WorldClim_2.1_INM-CM5-0_ssp245_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Sep,P Sep,september,mm per month,*mm~mo^-1*, +precipitation_10,precipitation_10,WorldClim_2.1_INM-CM5-0_ssp245_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Oct,P Oct,october,mm per month,*mm~mo^-1*, +precipitation_11,precipitation_11,WorldClim_2.1_INM-CM5-0_ssp245_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Nov,P Nov,november,mm per month,*mm~mo^-1*, +precipitation_12,precipitation_12,WorldClim_2.1_INM-CM5-0_ssp245_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Dec,P Dec,december,mm per month,*mm~mo^-1*, +temperature_min_01,temperature_min_01,WorldClim_2.1_INM-CM5-0_ssp245_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jan,min T Jan,january,degrees Celsius,*degree*C*, +temperature_min_02,temperature_min_02,WorldClim_2.1_INM-CM5-0_ssp245_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Feb,min T Feb,february,degrees Celsius,*degree*C*, +temperature_min_03,temperature_min_03,WorldClim_2.1_INM-CM5-0_ssp245_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Mar,min T Mar,march,degrees Celsius,*degree*C*, +temperature_min_04,temperature_min_04,WorldClim_2.1_INM-CM5-0_ssp245_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Apr,min T Apr,april,degrees Celsius,*degree*C*, +temperature_min_05,temperature_min_05,WorldClim_2.1_INM-CM5-0_ssp245_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature May,min T May,may,degrees Celsius,*degree*C*, +temperature_min_06,temperature_min_06,WorldClim_2.1_INM-CM5-0_ssp245_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jun,min T Jun,june,degrees Celsius,*degree*C*, +temperature_min_07,temperature_min_07,WorldClim_2.1_INM-CM5-0_ssp245_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jul,min T Jul,july,degrees Celsius,*degree*C*, +temperature_min_08,temperature_min_08,WorldClim_2.1_INM-CM5-0_ssp245_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Aug,min T Aug,august,degrees Celsius,*degree*C*, +temperature_min_09,temperature_min_09,WorldClim_2.1_INM-CM5-0_ssp245_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Sep,min T Sep,september,degrees Celsius,*degree*C*, +temperature_min_10,temperature_min_10,WorldClim_2.1_INM-CM5-0_ssp245_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Oct,min T Oct,october,degrees Celsius,*degree*C*, +temperature_min_11,temperature_min_11,WorldClim_2.1_INM-CM5-0_ssp245_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Nov,min T Nov,november,degrees Celsius,*degree*C*, +temperature_min_12,temperature_min_12,WorldClim_2.1_INM-CM5-0_ssp245_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Dec,min T Dec,december,degrees Celsius,*degree*C*, +temperature_max_01,temperature_max_01,WorldClim_2.1_INM-CM5-0_ssp245_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jan,max T Jan,january,degrees Celsius,*degree*C*, +temperature_max_02,temperature_max_02,WorldClim_2.1_INM-CM5-0_ssp245_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Feb,max T Feb,february,degrees Celsius,*degree*C*, +temperature_max_03,temperature_max_03,WorldClim_2.1_INM-CM5-0_ssp245_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Mar,max T Mar,march,degrees Celsius,*degree*C*, +temperature_max_04,temperature_max_04,WorldClim_2.1_INM-CM5-0_ssp245_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Apr,max T Apr,april,degrees Celsius,*degree*C*, +temperature_max_05,temperature_max_05,WorldClim_2.1_INM-CM5-0_ssp245_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature May,max T May,may,degrees Celsius,*degree*C*, +temperature_max_06,temperature_max_06,WorldClim_2.1_INM-CM5-0_ssp245_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jun,max T Jun,june,degrees Celsius,*degree*C*, +temperature_max_07,temperature_max_07,WorldClim_2.1_INM-CM5-0_ssp245_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jul,max T Jul,july,degrees Celsius,*degree*C*, +temperature_max_08,temperature_max_08,WorldClim_2.1_INM-CM5-0_ssp245_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Aug,max T Aug,august,degrees Celsius,*degree*C*, +temperature_max_09,temperature_max_09,WorldClim_2.1_INM-CM5-0_ssp245_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Sep,max T Sep,september,degrees Celsius,*degree*C*, +temperature_max_10,temperature_max_10,WorldClim_2.1_INM-CM5-0_ssp245_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Oct,max T Oct,october,degrees Celsius,*degree*C*, +temperature_max_11,temperature_max_11,WorldClim_2.1_INM-CM5-0_ssp245_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Nov,max T Nov,november,degrees Celsius,*degree*C*, +temperature_max_12,temperature_max_12,WorldClim_2.1_INM-CM5-0_ssp245_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Dec,max T Dec,december,degrees Celsius,*degree*C*, +bio01,bio01,WorldClim_2.1_INM-CM5-0_ssp245_5m,FALSE,WorldClim_2.1_INM-CM5-0_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual mean temperature,ann. mean T,year,degrees Celsius,*degree*C*, +bio02,bio02,WorldClim_2.1_INM-CM5-0_ssp245_5m,FALSE,WorldClim_2.1_INM-CM5-0_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean diurnal range,diurn. range,year,degrees Celsius,*degree*C*, +bio03,bio03,WorldClim_2.1_INM-CM5-0_ssp245_5m,FALSE,WorldClim_2.1_INM-CM5-0_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,isothermality,isothermality,year,,, +bio04,bio04,WorldClim_2.1_INM-CM5-0_ssp245_5m,FALSE,WorldClim_2.1_INM-CM5-0_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature seasonality,T season.,year,degrees Celsius,*degree*C*, +bio05,bio05,WorldClim_2.1_INM-CM5-0_ssp245_5m,FALSE,WorldClim_2.1_INM-CM5-0_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature of warmest month,max. T of warmest mo.,year,degrees Celsius,*degree*C*, +bio06,bio06,WorldClim_2.1_INM-CM5-0_ssp245_5m,FALSE,WorldClim_2.1_INM-CM5-0_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature of coldest month,min. T of coldest mo.,year,degrees Celsius,*degree*C*, +bio07,bio07,WorldClim_2.1_INM-CM5-0_ssp245_5m,FALSE,WorldClim_2.1_INM-CM5-0_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature annual range (bio05-bio06),T ann. Range,year,degrees Celsius,*degree*C*, +bio08,bio08,WorldClim_2.1_INM-CM5-0_ssp245_5m,FALSE,WorldClim_2.1_INM-CM5-0_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of wettest quarter,mean T of wettest qtr,year,degrees Celsius,*degree*C*, +bio09,bio09,WorldClim_2.1_INM-CM5-0_ssp245_5m,FALSE,WorldClim_2.1_INM-CM5-0_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of driest quarter,mean T of driest qtr,year,degrees Celsius,*degree*C*, +bio10,bio10,WorldClim_2.1_INM-CM5-0_ssp245_5m,FALSE,WorldClim_2.1_INM-CM5-0_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of warmest quarter,mean T of warmest qtr,year,degrees Celsius,*degree*C*, +bio11,bio11,WorldClim_2.1_INM-CM5-0_ssp245_5m,FALSE,WorldClim_2.1_INM-CM5-0_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of coldest quarter,mean T of coldest qtr,year,degrees Celsius,*degree*C*, +bio12,bio12,WorldClim_2.1_INM-CM5-0_ssp245_5m,FALSE,WorldClim_2.1_INM-CM5-0_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual precipitation,ann. P,year,mm per year,*mm~yr^-1*, +bio13,bio13,WorldClim_2.1_INM-CM5-0_ssp245_5m,FALSE,WorldClim_2.1_INM-CM5-0_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest month,P of wettest mo.,year,mm per month,*mm~mo^-1*, +bio14,bio14,WorldClim_2.1_INM-CM5-0_ssp245_5m,FALSE,WorldClim_2.1_INM-CM5-0_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest month,P of driest mo.,year,mm per month,*mm~mo^-1*, +bio15,bio15,WorldClim_2.1_INM-CM5-0_ssp245_5m,FALSE,WorldClim_2.1_INM-CM5-0_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation seasonality (coeff var),P season.,year,,, +bio16,bio16,WorldClim_2.1_INM-CM5-0_ssp245_5m,FALSE,WorldClim_2.1_INM-CM5-0_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest quarter,P of wettest qtr,year,mm per quarter,*mm~qtr^-1*, +bio17,bio17,WorldClim_2.1_INM-CM5-0_ssp245_5m,FALSE,WorldClim_2.1_INM-CM5-0_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest quarter,P of driest qtr,year,mm per quarter,*mm~qtr^-1*, +bio18,bio18,WorldClim_2.1_INM-CM5-0_ssp245_5m,FALSE,WorldClim_2.1_INM-CM5-0_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of warmest quarter,P of warmest qtr,year,mm per quarter,*mm~qtr^-1*, +bio19,bio19,WorldClim_2.1_INM-CM5-0_ssp245_5m,FALSE,WorldClim_2.1_INM-CM5-0_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of coldest quarter,P of coldest qtr,year,mm per quarter,*mm~qtr^-1*, +precipitation_01,precipitation_01,WorldClim_2.1_INM-CM5-0_ssp245_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jan,P Jan,january,mm per month,*mm~mo^-1*, +precipitation_02,precipitation_02,WorldClim_2.1_INM-CM5-0_ssp245_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Feb,P Feb,february,mm per month,*mm~mo^-1*, +precipitation_03,precipitation_03,WorldClim_2.1_INM-CM5-0_ssp245_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Mar,P Mar,march,mm per month,*mm~mo^-1*, +precipitation_04,precipitation_04,WorldClim_2.1_INM-CM5-0_ssp245_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Apr,P Apr,april,mm per month,*mm~mo^-1*, +precipitation_05,precipitation_05,WorldClim_2.1_INM-CM5-0_ssp245_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation May,P May,may,mm per month,*mm~mo^-1*, +precipitation_06,precipitation_06,WorldClim_2.1_INM-CM5-0_ssp245_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jun,P Jun,june,mm per month,*mm~mo^-1*, +precipitation_07,precipitation_07,WorldClim_2.1_INM-CM5-0_ssp245_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jul,P Jul,july,mm per month,*mm~mo^-1*, +precipitation_08,precipitation_08,WorldClim_2.1_INM-CM5-0_ssp245_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Aug,P Aug,august,mm per month,*mm~mo^-1*, +precipitation_09,precipitation_09,WorldClim_2.1_INM-CM5-0_ssp245_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Sep,P Sep,september,mm per month,*mm~mo^-1*, +precipitation_10,precipitation_10,WorldClim_2.1_INM-CM5-0_ssp245_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Oct,P Oct,october,mm per month,*mm~mo^-1*, +precipitation_11,precipitation_11,WorldClim_2.1_INM-CM5-0_ssp245_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Nov,P Nov,november,mm per month,*mm~mo^-1*, +precipitation_12,precipitation_12,WorldClim_2.1_INM-CM5-0_ssp245_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Dec,P Dec,december,mm per month,*mm~mo^-1*, +temperature_min_01,temperature_min_01,WorldClim_2.1_INM-CM5-0_ssp245_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jan,min T Jan,january,degrees Celsius,*degree*C*, +temperature_min_02,temperature_min_02,WorldClim_2.1_INM-CM5-0_ssp245_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Feb,min T Feb,february,degrees Celsius,*degree*C*, +temperature_min_03,temperature_min_03,WorldClim_2.1_INM-CM5-0_ssp245_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Mar,min T Mar,march,degrees Celsius,*degree*C*, +temperature_min_04,temperature_min_04,WorldClim_2.1_INM-CM5-0_ssp245_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Apr,min T Apr,april,degrees Celsius,*degree*C*, +temperature_min_05,temperature_min_05,WorldClim_2.1_INM-CM5-0_ssp245_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature May,min T May,may,degrees Celsius,*degree*C*, +temperature_min_06,temperature_min_06,WorldClim_2.1_INM-CM5-0_ssp245_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jun,min T Jun,june,degrees Celsius,*degree*C*, +temperature_min_07,temperature_min_07,WorldClim_2.1_INM-CM5-0_ssp245_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jul,min T Jul,july,degrees Celsius,*degree*C*, +temperature_min_08,temperature_min_08,WorldClim_2.1_INM-CM5-0_ssp245_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Aug,min T Aug,august,degrees Celsius,*degree*C*, +temperature_min_09,temperature_min_09,WorldClim_2.1_INM-CM5-0_ssp245_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Sep,min T Sep,september,degrees Celsius,*degree*C*, +temperature_min_10,temperature_min_10,WorldClim_2.1_INM-CM5-0_ssp245_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Oct,min T Oct,october,degrees Celsius,*degree*C*, +temperature_min_11,temperature_min_11,WorldClim_2.1_INM-CM5-0_ssp245_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Nov,min T Nov,november,degrees Celsius,*degree*C*, +temperature_min_12,temperature_min_12,WorldClim_2.1_INM-CM5-0_ssp245_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Dec,min T Dec,december,degrees Celsius,*degree*C*, +temperature_max_01,temperature_max_01,WorldClim_2.1_INM-CM5-0_ssp245_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jan,max T Jan,january,degrees Celsius,*degree*C*, +temperature_max_02,temperature_max_02,WorldClim_2.1_INM-CM5-0_ssp245_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Feb,max T Feb,february,degrees Celsius,*degree*C*, +temperature_max_03,temperature_max_03,WorldClim_2.1_INM-CM5-0_ssp245_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Mar,max T Mar,march,degrees Celsius,*degree*C*, +temperature_max_04,temperature_max_04,WorldClim_2.1_INM-CM5-0_ssp245_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Apr,max T Apr,april,degrees Celsius,*degree*C*, +temperature_max_05,temperature_max_05,WorldClim_2.1_INM-CM5-0_ssp245_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature May,max T May,may,degrees Celsius,*degree*C*, +temperature_max_06,temperature_max_06,WorldClim_2.1_INM-CM5-0_ssp245_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jun,max T Jun,june,degrees Celsius,*degree*C*, +temperature_max_07,temperature_max_07,WorldClim_2.1_INM-CM5-0_ssp245_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jul,max T Jul,july,degrees Celsius,*degree*C*, +temperature_max_08,temperature_max_08,WorldClim_2.1_INM-CM5-0_ssp245_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Aug,max T Aug,august,degrees Celsius,*degree*C*, +temperature_max_09,temperature_max_09,WorldClim_2.1_INM-CM5-0_ssp245_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Sep,max T Sep,september,degrees Celsius,*degree*C*, +temperature_max_10,temperature_max_10,WorldClim_2.1_INM-CM5-0_ssp245_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Oct,max T Oct,october,degrees Celsius,*degree*C*, +temperature_max_11,temperature_max_11,WorldClim_2.1_INM-CM5-0_ssp245_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Nov,max T Nov,november,degrees Celsius,*degree*C*, +temperature_max_12,temperature_max_12,WorldClim_2.1_INM-CM5-0_ssp245_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Dec,max T Dec,december,degrees Celsius,*degree*C*, +bio01,bio01,WorldClim_2.1_INM-CM5-0_ssp370_10m,FALSE,WorldClim_2.1_INM-CM5-0_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual mean temperature,ann. mean T,year,degrees Celsius,*degree*C*, +bio02,bio02,WorldClim_2.1_INM-CM5-0_ssp370_10m,FALSE,WorldClim_2.1_INM-CM5-0_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean diurnal range,diurn. range,year,degrees Celsius,*degree*C*, +bio03,bio03,WorldClim_2.1_INM-CM5-0_ssp370_10m,FALSE,WorldClim_2.1_INM-CM5-0_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,isothermality,isothermality,year,,, +bio04,bio04,WorldClim_2.1_INM-CM5-0_ssp370_10m,FALSE,WorldClim_2.1_INM-CM5-0_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature seasonality,T season.,year,degrees Celsius,*degree*C*, +bio05,bio05,WorldClim_2.1_INM-CM5-0_ssp370_10m,FALSE,WorldClim_2.1_INM-CM5-0_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature of warmest month,max. T of warmest mo.,year,degrees Celsius,*degree*C*, +bio06,bio06,WorldClim_2.1_INM-CM5-0_ssp370_10m,FALSE,WorldClim_2.1_INM-CM5-0_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature of coldest month,min. T of coldest mo.,year,degrees Celsius,*degree*C*, +bio07,bio07,WorldClim_2.1_INM-CM5-0_ssp370_10m,FALSE,WorldClim_2.1_INM-CM5-0_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature annual range (bio05-bio06),T ann. Range,year,degrees Celsius,*degree*C*, +bio08,bio08,WorldClim_2.1_INM-CM5-0_ssp370_10m,FALSE,WorldClim_2.1_INM-CM5-0_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of wettest quarter,mean T of wettest qtr,year,degrees Celsius,*degree*C*, +bio09,bio09,WorldClim_2.1_INM-CM5-0_ssp370_10m,FALSE,WorldClim_2.1_INM-CM5-0_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of driest quarter,mean T of driest qtr,year,degrees Celsius,*degree*C*, +bio10,bio10,WorldClim_2.1_INM-CM5-0_ssp370_10m,FALSE,WorldClim_2.1_INM-CM5-0_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of warmest quarter,mean T of warmest qtr,year,degrees Celsius,*degree*C*, +bio11,bio11,WorldClim_2.1_INM-CM5-0_ssp370_10m,FALSE,WorldClim_2.1_INM-CM5-0_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of coldest quarter,mean T of coldest qtr,year,degrees Celsius,*degree*C*, +bio12,bio12,WorldClim_2.1_INM-CM5-0_ssp370_10m,FALSE,WorldClim_2.1_INM-CM5-0_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual precipitation,ann. P,year,mm per year,*mm~yr^-1*, +bio13,bio13,WorldClim_2.1_INM-CM5-0_ssp370_10m,FALSE,WorldClim_2.1_INM-CM5-0_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest month,P of wettest mo.,year,mm per month,*mm~mo^-1*, +bio14,bio14,WorldClim_2.1_INM-CM5-0_ssp370_10m,FALSE,WorldClim_2.1_INM-CM5-0_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest month,P of driest mo.,year,mm per month,*mm~mo^-1*, +bio15,bio15,WorldClim_2.1_INM-CM5-0_ssp370_10m,FALSE,WorldClim_2.1_INM-CM5-0_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation seasonality (coeff var),P season.,year,,, +bio16,bio16,WorldClim_2.1_INM-CM5-0_ssp370_10m,FALSE,WorldClim_2.1_INM-CM5-0_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest quarter,P of wettest qtr,year,mm per quarter,*mm~qtr^-1*, +bio17,bio17,WorldClim_2.1_INM-CM5-0_ssp370_10m,FALSE,WorldClim_2.1_INM-CM5-0_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest quarter,P of driest qtr,year,mm per quarter,*mm~qtr^-1*, +bio18,bio18,WorldClim_2.1_INM-CM5-0_ssp370_10m,FALSE,WorldClim_2.1_INM-CM5-0_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of warmest quarter,P of warmest qtr,year,mm per quarter,*mm~qtr^-1*, +bio19,bio19,WorldClim_2.1_INM-CM5-0_ssp370_10m,FALSE,WorldClim_2.1_INM-CM5-0_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of coldest quarter,P of coldest qtr,year,mm per quarter,*mm~qtr^-1*, +precipitation_01,precipitation_01,WorldClim_2.1_INM-CM5-0_ssp370_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jan,P Jan,january,mm per month,*mm~mo^-1*, +precipitation_02,precipitation_02,WorldClim_2.1_INM-CM5-0_ssp370_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Feb,P Feb,february,mm per month,*mm~mo^-1*, +precipitation_03,precipitation_03,WorldClim_2.1_INM-CM5-0_ssp370_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Mar,P Mar,march,mm per month,*mm~mo^-1*, +precipitation_04,precipitation_04,WorldClim_2.1_INM-CM5-0_ssp370_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Apr,P Apr,april,mm per month,*mm~mo^-1*, +precipitation_05,precipitation_05,WorldClim_2.1_INM-CM5-0_ssp370_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation May,P May,may,mm per month,*mm~mo^-1*, +precipitation_06,precipitation_06,WorldClim_2.1_INM-CM5-0_ssp370_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jun,P Jun,june,mm per month,*mm~mo^-1*, +precipitation_07,precipitation_07,WorldClim_2.1_INM-CM5-0_ssp370_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jul,P Jul,july,mm per month,*mm~mo^-1*, +precipitation_08,precipitation_08,WorldClim_2.1_INM-CM5-0_ssp370_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Aug,P Aug,august,mm per month,*mm~mo^-1*, +precipitation_09,precipitation_09,WorldClim_2.1_INM-CM5-0_ssp370_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Sep,P Sep,september,mm per month,*mm~mo^-1*, +precipitation_10,precipitation_10,WorldClim_2.1_INM-CM5-0_ssp370_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Oct,P Oct,october,mm per month,*mm~mo^-1*, +precipitation_11,precipitation_11,WorldClim_2.1_INM-CM5-0_ssp370_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Nov,P Nov,november,mm per month,*mm~mo^-1*, +precipitation_12,precipitation_12,WorldClim_2.1_INM-CM5-0_ssp370_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Dec,P Dec,december,mm per month,*mm~mo^-1*, +temperature_min_01,temperature_min_01,WorldClim_2.1_INM-CM5-0_ssp370_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jan,min T Jan,january,degrees Celsius,*degree*C*, +temperature_min_02,temperature_min_02,WorldClim_2.1_INM-CM5-0_ssp370_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Feb,min T Feb,february,degrees Celsius,*degree*C*, +temperature_min_03,temperature_min_03,WorldClim_2.1_INM-CM5-0_ssp370_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Mar,min T Mar,march,degrees Celsius,*degree*C*, +temperature_min_04,temperature_min_04,WorldClim_2.1_INM-CM5-0_ssp370_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Apr,min T Apr,april,degrees Celsius,*degree*C*, +temperature_min_05,temperature_min_05,WorldClim_2.1_INM-CM5-0_ssp370_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature May,min T May,may,degrees Celsius,*degree*C*, +temperature_min_06,temperature_min_06,WorldClim_2.1_INM-CM5-0_ssp370_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jun,min T Jun,june,degrees Celsius,*degree*C*, +temperature_min_07,temperature_min_07,WorldClim_2.1_INM-CM5-0_ssp370_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jul,min T Jul,july,degrees Celsius,*degree*C*, +temperature_min_08,temperature_min_08,WorldClim_2.1_INM-CM5-0_ssp370_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Aug,min T Aug,august,degrees Celsius,*degree*C*, +temperature_min_09,temperature_min_09,WorldClim_2.1_INM-CM5-0_ssp370_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Sep,min T Sep,september,degrees Celsius,*degree*C*, +temperature_min_10,temperature_min_10,WorldClim_2.1_INM-CM5-0_ssp370_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Oct,min T Oct,october,degrees Celsius,*degree*C*, +temperature_min_11,temperature_min_11,WorldClim_2.1_INM-CM5-0_ssp370_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Nov,min T Nov,november,degrees Celsius,*degree*C*, +temperature_min_12,temperature_min_12,WorldClim_2.1_INM-CM5-0_ssp370_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Dec,min T Dec,december,degrees Celsius,*degree*C*, +temperature_max_01,temperature_max_01,WorldClim_2.1_INM-CM5-0_ssp370_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jan,max T Jan,january,degrees Celsius,*degree*C*, +temperature_max_02,temperature_max_02,WorldClim_2.1_INM-CM5-0_ssp370_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Feb,max T Feb,february,degrees Celsius,*degree*C*, +temperature_max_03,temperature_max_03,WorldClim_2.1_INM-CM5-0_ssp370_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Mar,max T Mar,march,degrees Celsius,*degree*C*, +temperature_max_04,temperature_max_04,WorldClim_2.1_INM-CM5-0_ssp370_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Apr,max T Apr,april,degrees Celsius,*degree*C*, +temperature_max_05,temperature_max_05,WorldClim_2.1_INM-CM5-0_ssp370_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature May,max T May,may,degrees Celsius,*degree*C*, +temperature_max_06,temperature_max_06,WorldClim_2.1_INM-CM5-0_ssp370_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jun,max T Jun,june,degrees Celsius,*degree*C*, +temperature_max_07,temperature_max_07,WorldClim_2.1_INM-CM5-0_ssp370_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jul,max T Jul,july,degrees Celsius,*degree*C*, +temperature_max_08,temperature_max_08,WorldClim_2.1_INM-CM5-0_ssp370_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Aug,max T Aug,august,degrees Celsius,*degree*C*, +temperature_max_09,temperature_max_09,WorldClim_2.1_INM-CM5-0_ssp370_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Sep,max T Sep,september,degrees Celsius,*degree*C*, +temperature_max_10,temperature_max_10,WorldClim_2.1_INM-CM5-0_ssp370_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Oct,max T Oct,october,degrees Celsius,*degree*C*, +temperature_max_11,temperature_max_11,WorldClim_2.1_INM-CM5-0_ssp370_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Nov,max T Nov,november,degrees Celsius,*degree*C*, +temperature_max_12,temperature_max_12,WorldClim_2.1_INM-CM5-0_ssp370_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Dec,max T Dec,december,degrees Celsius,*degree*C*, +bio01,bio01,WorldClim_2.1_INM-CM5-0_ssp370_5m,FALSE,WorldClim_2.1_INM-CM5-0_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual mean temperature,ann. mean T,year,degrees Celsius,*degree*C*, +bio02,bio02,WorldClim_2.1_INM-CM5-0_ssp370_5m,FALSE,WorldClim_2.1_INM-CM5-0_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean diurnal range,diurn. range,year,degrees Celsius,*degree*C*, +bio03,bio03,WorldClim_2.1_INM-CM5-0_ssp370_5m,FALSE,WorldClim_2.1_INM-CM5-0_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,isothermality,isothermality,year,,, +bio04,bio04,WorldClim_2.1_INM-CM5-0_ssp370_5m,FALSE,WorldClim_2.1_INM-CM5-0_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature seasonality,T season.,year,degrees Celsius,*degree*C*, +bio05,bio05,WorldClim_2.1_INM-CM5-0_ssp370_5m,FALSE,WorldClim_2.1_INM-CM5-0_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature of warmest month,max. T of warmest mo.,year,degrees Celsius,*degree*C*, +bio06,bio06,WorldClim_2.1_INM-CM5-0_ssp370_5m,FALSE,WorldClim_2.1_INM-CM5-0_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature of coldest month,min. T of coldest mo.,year,degrees Celsius,*degree*C*, +bio07,bio07,WorldClim_2.1_INM-CM5-0_ssp370_5m,FALSE,WorldClim_2.1_INM-CM5-0_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature annual range (bio05-bio06),T ann. Range,year,degrees Celsius,*degree*C*, +bio08,bio08,WorldClim_2.1_INM-CM5-0_ssp370_5m,FALSE,WorldClim_2.1_INM-CM5-0_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of wettest quarter,mean T of wettest qtr,year,degrees Celsius,*degree*C*, +bio09,bio09,WorldClim_2.1_INM-CM5-0_ssp370_5m,FALSE,WorldClim_2.1_INM-CM5-0_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of driest quarter,mean T of driest qtr,year,degrees Celsius,*degree*C*, +bio10,bio10,WorldClim_2.1_INM-CM5-0_ssp370_5m,FALSE,WorldClim_2.1_INM-CM5-0_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of warmest quarter,mean T of warmest qtr,year,degrees Celsius,*degree*C*, +bio11,bio11,WorldClim_2.1_INM-CM5-0_ssp370_5m,FALSE,WorldClim_2.1_INM-CM5-0_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of coldest quarter,mean T of coldest qtr,year,degrees Celsius,*degree*C*, +bio12,bio12,WorldClim_2.1_INM-CM5-0_ssp370_5m,FALSE,WorldClim_2.1_INM-CM5-0_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual precipitation,ann. P,year,mm per year,*mm~yr^-1*, +bio13,bio13,WorldClim_2.1_INM-CM5-0_ssp370_5m,FALSE,WorldClim_2.1_INM-CM5-0_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest month,P of wettest mo.,year,mm per month,*mm~mo^-1*, +bio14,bio14,WorldClim_2.1_INM-CM5-0_ssp370_5m,FALSE,WorldClim_2.1_INM-CM5-0_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest month,P of driest mo.,year,mm per month,*mm~mo^-1*, +bio15,bio15,WorldClim_2.1_INM-CM5-0_ssp370_5m,FALSE,WorldClim_2.1_INM-CM5-0_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation seasonality (coeff var),P season.,year,,, +bio16,bio16,WorldClim_2.1_INM-CM5-0_ssp370_5m,FALSE,WorldClim_2.1_INM-CM5-0_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest quarter,P of wettest qtr,year,mm per quarter,*mm~qtr^-1*, +bio17,bio17,WorldClim_2.1_INM-CM5-0_ssp370_5m,FALSE,WorldClim_2.1_INM-CM5-0_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest quarter,P of driest qtr,year,mm per quarter,*mm~qtr^-1*, +bio18,bio18,WorldClim_2.1_INM-CM5-0_ssp370_5m,FALSE,WorldClim_2.1_INM-CM5-0_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of warmest quarter,P of warmest qtr,year,mm per quarter,*mm~qtr^-1*, +bio19,bio19,WorldClim_2.1_INM-CM5-0_ssp370_5m,FALSE,WorldClim_2.1_INM-CM5-0_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of coldest quarter,P of coldest qtr,year,mm per quarter,*mm~qtr^-1*, +precipitation_01,precipitation_01,WorldClim_2.1_INM-CM5-0_ssp370_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jan,P Jan,january,mm per month,*mm~mo^-1*, +precipitation_02,precipitation_02,WorldClim_2.1_INM-CM5-0_ssp370_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Feb,P Feb,february,mm per month,*mm~mo^-1*, +precipitation_03,precipitation_03,WorldClim_2.1_INM-CM5-0_ssp370_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Mar,P Mar,march,mm per month,*mm~mo^-1*, +precipitation_04,precipitation_04,WorldClim_2.1_INM-CM5-0_ssp370_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Apr,P Apr,april,mm per month,*mm~mo^-1*, +precipitation_05,precipitation_05,WorldClim_2.1_INM-CM5-0_ssp370_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation May,P May,may,mm per month,*mm~mo^-1*, +precipitation_06,precipitation_06,WorldClim_2.1_INM-CM5-0_ssp370_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jun,P Jun,june,mm per month,*mm~mo^-1*, +precipitation_07,precipitation_07,WorldClim_2.1_INM-CM5-0_ssp370_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jul,P Jul,july,mm per month,*mm~mo^-1*, +precipitation_08,precipitation_08,WorldClim_2.1_INM-CM5-0_ssp370_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Aug,P Aug,august,mm per month,*mm~mo^-1*, +precipitation_09,precipitation_09,WorldClim_2.1_INM-CM5-0_ssp370_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Sep,P Sep,september,mm per month,*mm~mo^-1*, +precipitation_10,precipitation_10,WorldClim_2.1_INM-CM5-0_ssp370_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Oct,P Oct,october,mm per month,*mm~mo^-1*, +precipitation_11,precipitation_11,WorldClim_2.1_INM-CM5-0_ssp370_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Nov,P Nov,november,mm per month,*mm~mo^-1*, +precipitation_12,precipitation_12,WorldClim_2.1_INM-CM5-0_ssp370_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Dec,P Dec,december,mm per month,*mm~mo^-1*, +temperature_min_01,temperature_min_01,WorldClim_2.1_INM-CM5-0_ssp370_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jan,min T Jan,january,degrees Celsius,*degree*C*, +temperature_min_02,temperature_min_02,WorldClim_2.1_INM-CM5-0_ssp370_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Feb,min T Feb,february,degrees Celsius,*degree*C*, +temperature_min_03,temperature_min_03,WorldClim_2.1_INM-CM5-0_ssp370_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Mar,min T Mar,march,degrees Celsius,*degree*C*, +temperature_min_04,temperature_min_04,WorldClim_2.1_INM-CM5-0_ssp370_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Apr,min T Apr,april,degrees Celsius,*degree*C*, +temperature_min_05,temperature_min_05,WorldClim_2.1_INM-CM5-0_ssp370_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature May,min T May,may,degrees Celsius,*degree*C*, +temperature_min_06,temperature_min_06,WorldClim_2.1_INM-CM5-0_ssp370_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jun,min T Jun,june,degrees Celsius,*degree*C*, +temperature_min_07,temperature_min_07,WorldClim_2.1_INM-CM5-0_ssp370_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jul,min T Jul,july,degrees Celsius,*degree*C*, +temperature_min_08,temperature_min_08,WorldClim_2.1_INM-CM5-0_ssp370_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Aug,min T Aug,august,degrees Celsius,*degree*C*, +temperature_min_09,temperature_min_09,WorldClim_2.1_INM-CM5-0_ssp370_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Sep,min T Sep,september,degrees Celsius,*degree*C*, +temperature_min_10,temperature_min_10,WorldClim_2.1_INM-CM5-0_ssp370_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Oct,min T Oct,october,degrees Celsius,*degree*C*, +temperature_min_11,temperature_min_11,WorldClim_2.1_INM-CM5-0_ssp370_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Nov,min T Nov,november,degrees Celsius,*degree*C*, +temperature_min_12,temperature_min_12,WorldClim_2.1_INM-CM5-0_ssp370_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Dec,min T Dec,december,degrees Celsius,*degree*C*, +temperature_max_01,temperature_max_01,WorldClim_2.1_INM-CM5-0_ssp370_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jan,max T Jan,january,degrees Celsius,*degree*C*, +temperature_max_02,temperature_max_02,WorldClim_2.1_INM-CM5-0_ssp370_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Feb,max T Feb,february,degrees Celsius,*degree*C*, +temperature_max_03,temperature_max_03,WorldClim_2.1_INM-CM5-0_ssp370_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Mar,max T Mar,march,degrees Celsius,*degree*C*, +temperature_max_04,temperature_max_04,WorldClim_2.1_INM-CM5-0_ssp370_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Apr,max T Apr,april,degrees Celsius,*degree*C*, +temperature_max_05,temperature_max_05,WorldClim_2.1_INM-CM5-0_ssp370_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature May,max T May,may,degrees Celsius,*degree*C*, +temperature_max_06,temperature_max_06,WorldClim_2.1_INM-CM5-0_ssp370_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jun,max T Jun,june,degrees Celsius,*degree*C*, +temperature_max_07,temperature_max_07,WorldClim_2.1_INM-CM5-0_ssp370_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jul,max T Jul,july,degrees Celsius,*degree*C*, +temperature_max_08,temperature_max_08,WorldClim_2.1_INM-CM5-0_ssp370_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Aug,max T Aug,august,degrees Celsius,*degree*C*, +temperature_max_09,temperature_max_09,WorldClim_2.1_INM-CM5-0_ssp370_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Sep,max T Sep,september,degrees Celsius,*degree*C*, +temperature_max_10,temperature_max_10,WorldClim_2.1_INM-CM5-0_ssp370_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Oct,max T Oct,october,degrees Celsius,*degree*C*, +temperature_max_11,temperature_max_11,WorldClim_2.1_INM-CM5-0_ssp370_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Nov,max T Nov,november,degrees Celsius,*degree*C*, +temperature_max_12,temperature_max_12,WorldClim_2.1_INM-CM5-0_ssp370_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Dec,max T Dec,december,degrees Celsius,*degree*C*, +bio01,bio01,WorldClim_2.1_INM-CM5-0_ssp585_10m,FALSE,WorldClim_2.1_INM-CM5-0_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual mean temperature,ann. mean T,year,degrees Celsius,*degree*C*, +bio02,bio02,WorldClim_2.1_INM-CM5-0_ssp585_10m,FALSE,WorldClim_2.1_INM-CM5-0_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean diurnal range,diurn. range,year,degrees Celsius,*degree*C*, +bio03,bio03,WorldClim_2.1_INM-CM5-0_ssp585_10m,FALSE,WorldClim_2.1_INM-CM5-0_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,isothermality,isothermality,year,,, +bio04,bio04,WorldClim_2.1_INM-CM5-0_ssp585_10m,FALSE,WorldClim_2.1_INM-CM5-0_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature seasonality,T season.,year,degrees Celsius,*degree*C*, +bio05,bio05,WorldClim_2.1_INM-CM5-0_ssp585_10m,FALSE,WorldClim_2.1_INM-CM5-0_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature of warmest month,max. T of warmest mo.,year,degrees Celsius,*degree*C*, +bio06,bio06,WorldClim_2.1_INM-CM5-0_ssp585_10m,FALSE,WorldClim_2.1_INM-CM5-0_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature of coldest month,min. T of coldest mo.,year,degrees Celsius,*degree*C*, +bio07,bio07,WorldClim_2.1_INM-CM5-0_ssp585_10m,FALSE,WorldClim_2.1_INM-CM5-0_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature annual range (bio05-bio06),T ann. Range,year,degrees Celsius,*degree*C*, +bio08,bio08,WorldClim_2.1_INM-CM5-0_ssp585_10m,FALSE,WorldClim_2.1_INM-CM5-0_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of wettest quarter,mean T of wettest qtr,year,degrees Celsius,*degree*C*, +bio09,bio09,WorldClim_2.1_INM-CM5-0_ssp585_10m,FALSE,WorldClim_2.1_INM-CM5-0_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of driest quarter,mean T of driest qtr,year,degrees Celsius,*degree*C*, +bio10,bio10,WorldClim_2.1_INM-CM5-0_ssp585_10m,FALSE,WorldClim_2.1_INM-CM5-0_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of warmest quarter,mean T of warmest qtr,year,degrees Celsius,*degree*C*, +bio11,bio11,WorldClim_2.1_INM-CM5-0_ssp585_10m,FALSE,WorldClim_2.1_INM-CM5-0_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of coldest quarter,mean T of coldest qtr,year,degrees Celsius,*degree*C*, +bio12,bio12,WorldClim_2.1_INM-CM5-0_ssp585_10m,FALSE,WorldClim_2.1_INM-CM5-0_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual precipitation,ann. P,year,mm per year,*mm~yr^-1*, +bio13,bio13,WorldClim_2.1_INM-CM5-0_ssp585_10m,FALSE,WorldClim_2.1_INM-CM5-0_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest month,P of wettest mo.,year,mm per month,*mm~mo^-1*, +bio14,bio14,WorldClim_2.1_INM-CM5-0_ssp585_10m,FALSE,WorldClim_2.1_INM-CM5-0_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest month,P of driest mo.,year,mm per month,*mm~mo^-1*, +bio15,bio15,WorldClim_2.1_INM-CM5-0_ssp585_10m,FALSE,WorldClim_2.1_INM-CM5-0_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation seasonality (coeff var),P season.,year,,, +bio16,bio16,WorldClim_2.1_INM-CM5-0_ssp585_10m,FALSE,WorldClim_2.1_INM-CM5-0_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest quarter,P of wettest qtr,year,mm per quarter,*mm~qtr^-1*, +bio17,bio17,WorldClim_2.1_INM-CM5-0_ssp585_10m,FALSE,WorldClim_2.1_INM-CM5-0_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest quarter,P of driest qtr,year,mm per quarter,*mm~qtr^-1*, +bio18,bio18,WorldClim_2.1_INM-CM5-0_ssp585_10m,FALSE,WorldClim_2.1_INM-CM5-0_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of warmest quarter,P of warmest qtr,year,mm per quarter,*mm~qtr^-1*, +bio19,bio19,WorldClim_2.1_INM-CM5-0_ssp585_10m,FALSE,WorldClim_2.1_INM-CM5-0_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of coldest quarter,P of coldest qtr,year,mm per quarter,*mm~qtr^-1*, +precipitation_01,precipitation_01,WorldClim_2.1_INM-CM5-0_ssp585_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jan,P Jan,january,mm per month,*mm~mo^-1*, +precipitation_02,precipitation_02,WorldClim_2.1_INM-CM5-0_ssp585_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Feb,P Feb,february,mm per month,*mm~mo^-1*, +precipitation_03,precipitation_03,WorldClim_2.1_INM-CM5-0_ssp585_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Mar,P Mar,march,mm per month,*mm~mo^-1*, +precipitation_04,precipitation_04,WorldClim_2.1_INM-CM5-0_ssp585_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Apr,P Apr,april,mm per month,*mm~mo^-1*, +precipitation_05,precipitation_05,WorldClim_2.1_INM-CM5-0_ssp585_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation May,P May,may,mm per month,*mm~mo^-1*, +precipitation_06,precipitation_06,WorldClim_2.1_INM-CM5-0_ssp585_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jun,P Jun,june,mm per month,*mm~mo^-1*, +precipitation_07,precipitation_07,WorldClim_2.1_INM-CM5-0_ssp585_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jul,P Jul,july,mm per month,*mm~mo^-1*, +precipitation_08,precipitation_08,WorldClim_2.1_INM-CM5-0_ssp585_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Aug,P Aug,august,mm per month,*mm~mo^-1*, +precipitation_09,precipitation_09,WorldClim_2.1_INM-CM5-0_ssp585_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Sep,P Sep,september,mm per month,*mm~mo^-1*, +precipitation_10,precipitation_10,WorldClim_2.1_INM-CM5-0_ssp585_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Oct,P Oct,october,mm per month,*mm~mo^-1*, +precipitation_11,precipitation_11,WorldClim_2.1_INM-CM5-0_ssp585_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Nov,P Nov,november,mm per month,*mm~mo^-1*, +precipitation_12,precipitation_12,WorldClim_2.1_INM-CM5-0_ssp585_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Dec,P Dec,december,mm per month,*mm~mo^-1*, +temperature_min_01,temperature_min_01,WorldClim_2.1_INM-CM5-0_ssp585_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jan,min T Jan,january,degrees Celsius,*degree*C*, +temperature_min_02,temperature_min_02,WorldClim_2.1_INM-CM5-0_ssp585_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Feb,min T Feb,february,degrees Celsius,*degree*C*, +temperature_min_03,temperature_min_03,WorldClim_2.1_INM-CM5-0_ssp585_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Mar,min T Mar,march,degrees Celsius,*degree*C*, +temperature_min_04,temperature_min_04,WorldClim_2.1_INM-CM5-0_ssp585_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Apr,min T Apr,april,degrees Celsius,*degree*C*, +temperature_min_05,temperature_min_05,WorldClim_2.1_INM-CM5-0_ssp585_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature May,min T May,may,degrees Celsius,*degree*C*, +temperature_min_06,temperature_min_06,WorldClim_2.1_INM-CM5-0_ssp585_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jun,min T Jun,june,degrees Celsius,*degree*C*, +temperature_min_07,temperature_min_07,WorldClim_2.1_INM-CM5-0_ssp585_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jul,min T Jul,july,degrees Celsius,*degree*C*, +temperature_min_08,temperature_min_08,WorldClim_2.1_INM-CM5-0_ssp585_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Aug,min T Aug,august,degrees Celsius,*degree*C*, +temperature_min_09,temperature_min_09,WorldClim_2.1_INM-CM5-0_ssp585_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Sep,min T Sep,september,degrees Celsius,*degree*C*, +temperature_min_10,temperature_min_10,WorldClim_2.1_INM-CM5-0_ssp585_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Oct,min T Oct,october,degrees Celsius,*degree*C*, +temperature_min_11,temperature_min_11,WorldClim_2.1_INM-CM5-0_ssp585_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Nov,min T Nov,november,degrees Celsius,*degree*C*, +temperature_min_12,temperature_min_12,WorldClim_2.1_INM-CM5-0_ssp585_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Dec,min T Dec,december,degrees Celsius,*degree*C*, +temperature_max_01,temperature_max_01,WorldClim_2.1_INM-CM5-0_ssp585_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jan,max T Jan,january,degrees Celsius,*degree*C*, +temperature_max_02,temperature_max_02,WorldClim_2.1_INM-CM5-0_ssp585_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Feb,max T Feb,february,degrees Celsius,*degree*C*, +temperature_max_03,temperature_max_03,WorldClim_2.1_INM-CM5-0_ssp585_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Mar,max T Mar,march,degrees Celsius,*degree*C*, +temperature_max_04,temperature_max_04,WorldClim_2.1_INM-CM5-0_ssp585_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Apr,max T Apr,april,degrees Celsius,*degree*C*, +temperature_max_05,temperature_max_05,WorldClim_2.1_INM-CM5-0_ssp585_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature May,max T May,may,degrees Celsius,*degree*C*, +temperature_max_06,temperature_max_06,WorldClim_2.1_INM-CM5-0_ssp585_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jun,max T Jun,june,degrees Celsius,*degree*C*, +temperature_max_07,temperature_max_07,WorldClim_2.1_INM-CM5-0_ssp585_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jul,max T Jul,july,degrees Celsius,*degree*C*, +temperature_max_08,temperature_max_08,WorldClim_2.1_INM-CM5-0_ssp585_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Aug,max T Aug,august,degrees Celsius,*degree*C*, +temperature_max_09,temperature_max_09,WorldClim_2.1_INM-CM5-0_ssp585_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Sep,max T Sep,september,degrees Celsius,*degree*C*, +temperature_max_10,temperature_max_10,WorldClim_2.1_INM-CM5-0_ssp585_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Oct,max T Oct,october,degrees Celsius,*degree*C*, +temperature_max_11,temperature_max_11,WorldClim_2.1_INM-CM5-0_ssp585_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Nov,max T Nov,november,degrees Celsius,*degree*C*, +temperature_max_12,temperature_max_12,WorldClim_2.1_INM-CM5-0_ssp585_10m,TRUE,WorldClim_2.1_INM-CM5-0_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Dec,max T Dec,december,degrees Celsius,*degree*C*, +bio01,bio01,WorldClim_2.1_INM-CM5-0_ssp585_5m,FALSE,WorldClim_2.1_INM-CM5-0_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual mean temperature,ann. mean T,year,degrees Celsius,*degree*C*, +bio02,bio02,WorldClim_2.1_INM-CM5-0_ssp585_5m,FALSE,WorldClim_2.1_INM-CM5-0_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean diurnal range,diurn. range,year,degrees Celsius,*degree*C*, +bio03,bio03,WorldClim_2.1_INM-CM5-0_ssp585_5m,FALSE,WorldClim_2.1_INM-CM5-0_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,isothermality,isothermality,year,,, +bio04,bio04,WorldClim_2.1_INM-CM5-0_ssp585_5m,FALSE,WorldClim_2.1_INM-CM5-0_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature seasonality,T season.,year,degrees Celsius,*degree*C*, +bio05,bio05,WorldClim_2.1_INM-CM5-0_ssp585_5m,FALSE,WorldClim_2.1_INM-CM5-0_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature of warmest month,max. T of warmest mo.,year,degrees Celsius,*degree*C*, +bio06,bio06,WorldClim_2.1_INM-CM5-0_ssp585_5m,FALSE,WorldClim_2.1_INM-CM5-0_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature of coldest month,min. T of coldest mo.,year,degrees Celsius,*degree*C*, +bio07,bio07,WorldClim_2.1_INM-CM5-0_ssp585_5m,FALSE,WorldClim_2.1_INM-CM5-0_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature annual range (bio05-bio06),T ann. Range,year,degrees Celsius,*degree*C*, +bio08,bio08,WorldClim_2.1_INM-CM5-0_ssp585_5m,FALSE,WorldClim_2.1_INM-CM5-0_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of wettest quarter,mean T of wettest qtr,year,degrees Celsius,*degree*C*, +bio09,bio09,WorldClim_2.1_INM-CM5-0_ssp585_5m,FALSE,WorldClim_2.1_INM-CM5-0_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of driest quarter,mean T of driest qtr,year,degrees Celsius,*degree*C*, +bio10,bio10,WorldClim_2.1_INM-CM5-0_ssp585_5m,FALSE,WorldClim_2.1_INM-CM5-0_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of warmest quarter,mean T of warmest qtr,year,degrees Celsius,*degree*C*, +bio11,bio11,WorldClim_2.1_INM-CM5-0_ssp585_5m,FALSE,WorldClim_2.1_INM-CM5-0_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of coldest quarter,mean T of coldest qtr,year,degrees Celsius,*degree*C*, +bio12,bio12,WorldClim_2.1_INM-CM5-0_ssp585_5m,FALSE,WorldClim_2.1_INM-CM5-0_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual precipitation,ann. P,year,mm per year,*mm~yr^-1*, +bio13,bio13,WorldClim_2.1_INM-CM5-0_ssp585_5m,FALSE,WorldClim_2.1_INM-CM5-0_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest month,P of wettest mo.,year,mm per month,*mm~mo^-1*, +bio14,bio14,WorldClim_2.1_INM-CM5-0_ssp585_5m,FALSE,WorldClim_2.1_INM-CM5-0_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest month,P of driest mo.,year,mm per month,*mm~mo^-1*, +bio15,bio15,WorldClim_2.1_INM-CM5-0_ssp585_5m,FALSE,WorldClim_2.1_INM-CM5-0_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation seasonality (coeff var),P season.,year,,, +bio16,bio16,WorldClim_2.1_INM-CM5-0_ssp585_5m,FALSE,WorldClim_2.1_INM-CM5-0_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest quarter,P of wettest qtr,year,mm per quarter,*mm~qtr^-1*, +bio17,bio17,WorldClim_2.1_INM-CM5-0_ssp585_5m,FALSE,WorldClim_2.1_INM-CM5-0_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest quarter,P of driest qtr,year,mm per quarter,*mm~qtr^-1*, +bio18,bio18,WorldClim_2.1_INM-CM5-0_ssp585_5m,FALSE,WorldClim_2.1_INM-CM5-0_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of warmest quarter,P of warmest qtr,year,mm per quarter,*mm~qtr^-1*, +bio19,bio19,WorldClim_2.1_INM-CM5-0_ssp585_5m,FALSE,WorldClim_2.1_INM-CM5-0_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of coldest quarter,P of coldest qtr,year,mm per quarter,*mm~qtr^-1*, +precipitation_01,precipitation_01,WorldClim_2.1_INM-CM5-0_ssp585_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jan,P Jan,january,mm per month,*mm~mo^-1*, +precipitation_02,precipitation_02,WorldClim_2.1_INM-CM5-0_ssp585_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Feb,P Feb,february,mm per month,*mm~mo^-1*, +precipitation_03,precipitation_03,WorldClim_2.1_INM-CM5-0_ssp585_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Mar,P Mar,march,mm per month,*mm~mo^-1*, +precipitation_04,precipitation_04,WorldClim_2.1_INM-CM5-0_ssp585_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Apr,P Apr,april,mm per month,*mm~mo^-1*, +precipitation_05,precipitation_05,WorldClim_2.1_INM-CM5-0_ssp585_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation May,P May,may,mm per month,*mm~mo^-1*, +precipitation_06,precipitation_06,WorldClim_2.1_INM-CM5-0_ssp585_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jun,P Jun,june,mm per month,*mm~mo^-1*, +precipitation_07,precipitation_07,WorldClim_2.1_INM-CM5-0_ssp585_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jul,P Jul,july,mm per month,*mm~mo^-1*, +precipitation_08,precipitation_08,WorldClim_2.1_INM-CM5-0_ssp585_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Aug,P Aug,august,mm per month,*mm~mo^-1*, +precipitation_09,precipitation_09,WorldClim_2.1_INM-CM5-0_ssp585_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Sep,P Sep,september,mm per month,*mm~mo^-1*, +precipitation_10,precipitation_10,WorldClim_2.1_INM-CM5-0_ssp585_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Oct,P Oct,october,mm per month,*mm~mo^-1*, +precipitation_11,precipitation_11,WorldClim_2.1_INM-CM5-0_ssp585_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Nov,P Nov,november,mm per month,*mm~mo^-1*, +precipitation_12,precipitation_12,WorldClim_2.1_INM-CM5-0_ssp585_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Dec,P Dec,december,mm per month,*mm~mo^-1*, +temperature_min_01,temperature_min_01,WorldClim_2.1_INM-CM5-0_ssp585_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jan,min T Jan,january,degrees Celsius,*degree*C*, +temperature_min_02,temperature_min_02,WorldClim_2.1_INM-CM5-0_ssp585_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Feb,min T Feb,february,degrees Celsius,*degree*C*, +temperature_min_03,temperature_min_03,WorldClim_2.1_INM-CM5-0_ssp585_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Mar,min T Mar,march,degrees Celsius,*degree*C*, +temperature_min_04,temperature_min_04,WorldClim_2.1_INM-CM5-0_ssp585_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Apr,min T Apr,april,degrees Celsius,*degree*C*, +temperature_min_05,temperature_min_05,WorldClim_2.1_INM-CM5-0_ssp585_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature May,min T May,may,degrees Celsius,*degree*C*, +temperature_min_06,temperature_min_06,WorldClim_2.1_INM-CM5-0_ssp585_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jun,min T Jun,june,degrees Celsius,*degree*C*, +temperature_min_07,temperature_min_07,WorldClim_2.1_INM-CM5-0_ssp585_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jul,min T Jul,july,degrees Celsius,*degree*C*, +temperature_min_08,temperature_min_08,WorldClim_2.1_INM-CM5-0_ssp585_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Aug,min T Aug,august,degrees Celsius,*degree*C*, +temperature_min_09,temperature_min_09,WorldClim_2.1_INM-CM5-0_ssp585_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Sep,min T Sep,september,degrees Celsius,*degree*C*, +temperature_min_10,temperature_min_10,WorldClim_2.1_INM-CM5-0_ssp585_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Oct,min T Oct,october,degrees Celsius,*degree*C*, +temperature_min_11,temperature_min_11,WorldClim_2.1_INM-CM5-0_ssp585_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Nov,min T Nov,november,degrees Celsius,*degree*C*, +temperature_min_12,temperature_min_12,WorldClim_2.1_INM-CM5-0_ssp585_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Dec,min T Dec,december,degrees Celsius,*degree*C*, +temperature_max_01,temperature_max_01,WorldClim_2.1_INM-CM5-0_ssp585_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jan,max T Jan,january,degrees Celsius,*degree*C*, +temperature_max_02,temperature_max_02,WorldClim_2.1_INM-CM5-0_ssp585_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Feb,max T Feb,february,degrees Celsius,*degree*C*, +temperature_max_03,temperature_max_03,WorldClim_2.1_INM-CM5-0_ssp585_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Mar,max T Mar,march,degrees Celsius,*degree*C*, +temperature_max_04,temperature_max_04,WorldClim_2.1_INM-CM5-0_ssp585_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Apr,max T Apr,april,degrees Celsius,*degree*C*, +temperature_max_05,temperature_max_05,WorldClim_2.1_INM-CM5-0_ssp585_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature May,max T May,may,degrees Celsius,*degree*C*, +temperature_max_06,temperature_max_06,WorldClim_2.1_INM-CM5-0_ssp585_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jun,max T Jun,june,degrees Celsius,*degree*C*, +temperature_max_07,temperature_max_07,WorldClim_2.1_INM-CM5-0_ssp585_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jul,max T Jul,july,degrees Celsius,*degree*C*, +temperature_max_08,temperature_max_08,WorldClim_2.1_INM-CM5-0_ssp585_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Aug,max T Aug,august,degrees Celsius,*degree*C*, +temperature_max_09,temperature_max_09,WorldClim_2.1_INM-CM5-0_ssp585_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Sep,max T Sep,september,degrees Celsius,*degree*C*, +temperature_max_10,temperature_max_10,WorldClim_2.1_INM-CM5-0_ssp585_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Oct,max T Oct,october,degrees Celsius,*degree*C*, +temperature_max_11,temperature_max_11,WorldClim_2.1_INM-CM5-0_ssp585_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Nov,max T Nov,november,degrees Celsius,*degree*C*, +temperature_max_12,temperature_max_12,WorldClim_2.1_INM-CM5-0_ssp585_5m,TRUE,WorldClim_2.1_INM-CM5-0_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Dec,max T Dec,december,degrees Celsius,*degree*C*, +bio01,bio01,WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual mean temperature,ann. mean T,year,degrees Celsius,*degree*C*, +bio02,bio02,WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean diurnal range,diurn. range,year,degrees Celsius,*degree*C*, +bio03,bio03,WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,isothermality,isothermality,year,,, +bio04,bio04,WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature seasonality,T season.,year,degrees Celsius,*degree*C*, +bio05,bio05,WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature of warmest month,max. T of warmest mo.,year,degrees Celsius,*degree*C*, +bio06,bio06,WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature of coldest month,min. T of coldest mo.,year,degrees Celsius,*degree*C*, +bio07,bio07,WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature annual range (bio05-bio06),T ann. Range,year,degrees Celsius,*degree*C*, +bio08,bio08,WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of wettest quarter,mean T of wettest qtr,year,degrees Celsius,*degree*C*, +bio09,bio09,WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of driest quarter,mean T of driest qtr,year,degrees Celsius,*degree*C*, +bio10,bio10,WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of warmest quarter,mean T of warmest qtr,year,degrees Celsius,*degree*C*, +bio11,bio11,WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of coldest quarter,mean T of coldest qtr,year,degrees Celsius,*degree*C*, +bio12,bio12,WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual precipitation,ann. P,year,mm per year,*mm~yr^-1*, +bio13,bio13,WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest month,P of wettest mo.,year,mm per month,*mm~mo^-1*, +bio14,bio14,WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest month,P of driest mo.,year,mm per month,*mm~mo^-1*, +bio15,bio15,WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation seasonality (coeff var),P season.,year,,, +bio16,bio16,WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest quarter,P of wettest qtr,year,mm per quarter,*mm~qtr^-1*, +bio17,bio17,WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest quarter,P of driest qtr,year,mm per quarter,*mm~qtr^-1*, +bio18,bio18,WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of warmest quarter,P of warmest qtr,year,mm per quarter,*mm~qtr^-1*, +bio19,bio19,WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of coldest quarter,P of coldest qtr,year,mm per quarter,*mm~qtr^-1*, +precipitation_01,precipitation_01,WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jan,P Jan,january,mm per month,*mm~mo^-1*, +precipitation_02,precipitation_02,WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Feb,P Feb,february,mm per month,*mm~mo^-1*, +precipitation_03,precipitation_03,WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Mar,P Mar,march,mm per month,*mm~mo^-1*, +precipitation_04,precipitation_04,WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Apr,P Apr,april,mm per month,*mm~mo^-1*, +precipitation_05,precipitation_05,WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation May,P May,may,mm per month,*mm~mo^-1*, +precipitation_06,precipitation_06,WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jun,P Jun,june,mm per month,*mm~mo^-1*, +precipitation_07,precipitation_07,WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jul,P Jul,july,mm per month,*mm~mo^-1*, +precipitation_08,precipitation_08,WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Aug,P Aug,august,mm per month,*mm~mo^-1*, +precipitation_09,precipitation_09,WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Sep,P Sep,september,mm per month,*mm~mo^-1*, +precipitation_10,precipitation_10,WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Oct,P Oct,october,mm per month,*mm~mo^-1*, +precipitation_11,precipitation_11,WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Nov,P Nov,november,mm per month,*mm~mo^-1*, +precipitation_12,precipitation_12,WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Dec,P Dec,december,mm per month,*mm~mo^-1*, +temperature_min_01,temperature_min_01,WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jan,min T Jan,january,degrees Celsius,*degree*C*, +temperature_min_02,temperature_min_02,WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Feb,min T Feb,february,degrees Celsius,*degree*C*, +temperature_min_03,temperature_min_03,WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Mar,min T Mar,march,degrees Celsius,*degree*C*, +temperature_min_04,temperature_min_04,WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Apr,min T Apr,april,degrees Celsius,*degree*C*, +temperature_min_05,temperature_min_05,WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature May,min T May,may,degrees Celsius,*degree*C*, +temperature_min_06,temperature_min_06,WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jun,min T Jun,june,degrees Celsius,*degree*C*, +temperature_min_07,temperature_min_07,WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jul,min T Jul,july,degrees Celsius,*degree*C*, +temperature_min_08,temperature_min_08,WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Aug,min T Aug,august,degrees Celsius,*degree*C*, +temperature_min_09,temperature_min_09,WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Sep,min T Sep,september,degrees Celsius,*degree*C*, +temperature_min_10,temperature_min_10,WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Oct,min T Oct,october,degrees Celsius,*degree*C*, +temperature_min_11,temperature_min_11,WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Nov,min T Nov,november,degrees Celsius,*degree*C*, +temperature_min_12,temperature_min_12,WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Dec,min T Dec,december,degrees Celsius,*degree*C*, +temperature_max_01,temperature_max_01,WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jan,max T Jan,january,degrees Celsius,*degree*C*, +temperature_max_02,temperature_max_02,WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Feb,max T Feb,february,degrees Celsius,*degree*C*, +temperature_max_03,temperature_max_03,WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Mar,max T Mar,march,degrees Celsius,*degree*C*, +temperature_max_04,temperature_max_04,WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Apr,max T Apr,april,degrees Celsius,*degree*C*, +temperature_max_05,temperature_max_05,WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature May,max T May,may,degrees Celsius,*degree*C*, +temperature_max_06,temperature_max_06,WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jun,max T Jun,june,degrees Celsius,*degree*C*, +temperature_max_07,temperature_max_07,WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jul,max T Jul,july,degrees Celsius,*degree*C*, +temperature_max_08,temperature_max_08,WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Aug,max T Aug,august,degrees Celsius,*degree*C*, +temperature_max_09,temperature_max_09,WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Sep,max T Sep,september,degrees Celsius,*degree*C*, +temperature_max_10,temperature_max_10,WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Oct,max T Oct,october,degrees Celsius,*degree*C*, +temperature_max_11,temperature_max_11,WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Nov,max T Nov,november,degrees Celsius,*degree*C*, +temperature_max_12,temperature_max_12,WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Dec,max T Dec,december,degrees Celsius,*degree*C*, +bio01,bio01,WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual mean temperature,ann. mean T,year,degrees Celsius,*degree*C*, +bio02,bio02,WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean diurnal range,diurn. range,year,degrees Celsius,*degree*C*, +bio03,bio03,WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,isothermality,isothermality,year,,, +bio04,bio04,WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature seasonality,T season.,year,degrees Celsius,*degree*C*, +bio05,bio05,WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature of warmest month,max. T of warmest mo.,year,degrees Celsius,*degree*C*, +bio06,bio06,WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature of coldest month,min. T of coldest mo.,year,degrees Celsius,*degree*C*, +bio07,bio07,WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature annual range (bio05-bio06),T ann. Range,year,degrees Celsius,*degree*C*, +bio08,bio08,WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of wettest quarter,mean T of wettest qtr,year,degrees Celsius,*degree*C*, +bio09,bio09,WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of driest quarter,mean T of driest qtr,year,degrees Celsius,*degree*C*, +bio10,bio10,WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of warmest quarter,mean T of warmest qtr,year,degrees Celsius,*degree*C*, +bio11,bio11,WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of coldest quarter,mean T of coldest qtr,year,degrees Celsius,*degree*C*, +bio12,bio12,WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual precipitation,ann. P,year,mm per year,*mm~yr^-1*, +bio13,bio13,WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest month,P of wettest mo.,year,mm per month,*mm~mo^-1*, +bio14,bio14,WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest month,P of driest mo.,year,mm per month,*mm~mo^-1*, +bio15,bio15,WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation seasonality (coeff var),P season.,year,,, +bio16,bio16,WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest quarter,P of wettest qtr,year,mm per quarter,*mm~qtr^-1*, +bio17,bio17,WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest quarter,P of driest qtr,year,mm per quarter,*mm~qtr^-1*, +bio18,bio18,WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of warmest quarter,P of warmest qtr,year,mm per quarter,*mm~qtr^-1*, +bio19,bio19,WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of coldest quarter,P of coldest qtr,year,mm per quarter,*mm~qtr^-1*, +precipitation_01,precipitation_01,WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jan,P Jan,january,mm per month,*mm~mo^-1*, +precipitation_02,precipitation_02,WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Feb,P Feb,february,mm per month,*mm~mo^-1*, +precipitation_03,precipitation_03,WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Mar,P Mar,march,mm per month,*mm~mo^-1*, +precipitation_04,precipitation_04,WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Apr,P Apr,april,mm per month,*mm~mo^-1*, +precipitation_05,precipitation_05,WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation May,P May,may,mm per month,*mm~mo^-1*, +precipitation_06,precipitation_06,WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jun,P Jun,june,mm per month,*mm~mo^-1*, +precipitation_07,precipitation_07,WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jul,P Jul,july,mm per month,*mm~mo^-1*, +precipitation_08,precipitation_08,WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Aug,P Aug,august,mm per month,*mm~mo^-1*, +precipitation_09,precipitation_09,WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Sep,P Sep,september,mm per month,*mm~mo^-1*, +precipitation_10,precipitation_10,WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Oct,P Oct,october,mm per month,*mm~mo^-1*, +precipitation_11,precipitation_11,WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Nov,P Nov,november,mm per month,*mm~mo^-1*, +precipitation_12,precipitation_12,WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Dec,P Dec,december,mm per month,*mm~mo^-1*, +temperature_min_01,temperature_min_01,WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jan,min T Jan,january,degrees Celsius,*degree*C*, +temperature_min_02,temperature_min_02,WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Feb,min T Feb,february,degrees Celsius,*degree*C*, +temperature_min_03,temperature_min_03,WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Mar,min T Mar,march,degrees Celsius,*degree*C*, +temperature_min_04,temperature_min_04,WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Apr,min T Apr,april,degrees Celsius,*degree*C*, +temperature_min_05,temperature_min_05,WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature May,min T May,may,degrees Celsius,*degree*C*, +temperature_min_06,temperature_min_06,WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jun,min T Jun,june,degrees Celsius,*degree*C*, +temperature_min_07,temperature_min_07,WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jul,min T Jul,july,degrees Celsius,*degree*C*, +temperature_min_08,temperature_min_08,WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Aug,min T Aug,august,degrees Celsius,*degree*C*, +temperature_min_09,temperature_min_09,WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Sep,min T Sep,september,degrees Celsius,*degree*C*, +temperature_min_10,temperature_min_10,WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Oct,min T Oct,october,degrees Celsius,*degree*C*, +temperature_min_11,temperature_min_11,WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Nov,min T Nov,november,degrees Celsius,*degree*C*, +temperature_min_12,temperature_min_12,WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Dec,min T Dec,december,degrees Celsius,*degree*C*, +temperature_max_01,temperature_max_01,WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jan,max T Jan,january,degrees Celsius,*degree*C*, +temperature_max_02,temperature_max_02,WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Feb,max T Feb,february,degrees Celsius,*degree*C*, +temperature_max_03,temperature_max_03,WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Mar,max T Mar,march,degrees Celsius,*degree*C*, +temperature_max_04,temperature_max_04,WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Apr,max T Apr,april,degrees Celsius,*degree*C*, +temperature_max_05,temperature_max_05,WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature May,max T May,may,degrees Celsius,*degree*C*, +temperature_max_06,temperature_max_06,WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jun,max T Jun,june,degrees Celsius,*degree*C*, +temperature_max_07,temperature_max_07,WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jul,max T Jul,july,degrees Celsius,*degree*C*, +temperature_max_08,temperature_max_08,WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Aug,max T Aug,august,degrees Celsius,*degree*C*, +temperature_max_09,temperature_max_09,WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Sep,max T Sep,september,degrees Celsius,*degree*C*, +temperature_max_10,temperature_max_10,WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Oct,max T Oct,october,degrees Celsius,*degree*C*, +temperature_max_11,temperature_max_11,WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Nov,max T Nov,november,degrees Celsius,*degree*C*, +temperature_max_12,temperature_max_12,WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Dec,max T Dec,december,degrees Celsius,*degree*C*, +bio01,bio01,WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual mean temperature,ann. mean T,year,degrees Celsius,*degree*C*, +bio02,bio02,WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean diurnal range,diurn. range,year,degrees Celsius,*degree*C*, +bio03,bio03,WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,isothermality,isothermality,year,,, +bio04,bio04,WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature seasonality,T season.,year,degrees Celsius,*degree*C*, +bio05,bio05,WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature of warmest month,max. T of warmest mo.,year,degrees Celsius,*degree*C*, +bio06,bio06,WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature of coldest month,min. T of coldest mo.,year,degrees Celsius,*degree*C*, +bio07,bio07,WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature annual range (bio05-bio06),T ann. Range,year,degrees Celsius,*degree*C*, +bio08,bio08,WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of wettest quarter,mean T of wettest qtr,year,degrees Celsius,*degree*C*, +bio09,bio09,WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of driest quarter,mean T of driest qtr,year,degrees Celsius,*degree*C*, +bio10,bio10,WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of warmest quarter,mean T of warmest qtr,year,degrees Celsius,*degree*C*, +bio11,bio11,WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of coldest quarter,mean T of coldest qtr,year,degrees Celsius,*degree*C*, +bio12,bio12,WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual precipitation,ann. P,year,mm per year,*mm~yr^-1*, +bio13,bio13,WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest month,P of wettest mo.,year,mm per month,*mm~mo^-1*, +bio14,bio14,WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest month,P of driest mo.,year,mm per month,*mm~mo^-1*, +bio15,bio15,WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation seasonality (coeff var),P season.,year,,, +bio16,bio16,WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest quarter,P of wettest qtr,year,mm per quarter,*mm~qtr^-1*, +bio17,bio17,WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest quarter,P of driest qtr,year,mm per quarter,*mm~qtr^-1*, +bio18,bio18,WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of warmest quarter,P of warmest qtr,year,mm per quarter,*mm~qtr^-1*, +bio19,bio19,WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of coldest quarter,P of coldest qtr,year,mm per quarter,*mm~qtr^-1*, +precipitation_01,precipitation_01,WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jan,P Jan,january,mm per month,*mm~mo^-1*, +precipitation_02,precipitation_02,WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Feb,P Feb,february,mm per month,*mm~mo^-1*, +precipitation_03,precipitation_03,WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Mar,P Mar,march,mm per month,*mm~mo^-1*, +precipitation_04,precipitation_04,WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Apr,P Apr,april,mm per month,*mm~mo^-1*, +precipitation_05,precipitation_05,WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation May,P May,may,mm per month,*mm~mo^-1*, +precipitation_06,precipitation_06,WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jun,P Jun,june,mm per month,*mm~mo^-1*, +precipitation_07,precipitation_07,WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jul,P Jul,july,mm per month,*mm~mo^-1*, +precipitation_08,precipitation_08,WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Aug,P Aug,august,mm per month,*mm~mo^-1*, +precipitation_09,precipitation_09,WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Sep,P Sep,september,mm per month,*mm~mo^-1*, +precipitation_10,precipitation_10,WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Oct,P Oct,october,mm per month,*mm~mo^-1*, +precipitation_11,precipitation_11,WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Nov,P Nov,november,mm per month,*mm~mo^-1*, +precipitation_12,precipitation_12,WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Dec,P Dec,december,mm per month,*mm~mo^-1*, +temperature_min_01,temperature_min_01,WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jan,min T Jan,january,degrees Celsius,*degree*C*, +temperature_min_02,temperature_min_02,WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Feb,min T Feb,february,degrees Celsius,*degree*C*, +temperature_min_03,temperature_min_03,WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Mar,min T Mar,march,degrees Celsius,*degree*C*, +temperature_min_04,temperature_min_04,WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Apr,min T Apr,april,degrees Celsius,*degree*C*, +temperature_min_05,temperature_min_05,WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature May,min T May,may,degrees Celsius,*degree*C*, +temperature_min_06,temperature_min_06,WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jun,min T Jun,june,degrees Celsius,*degree*C*, +temperature_min_07,temperature_min_07,WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jul,min T Jul,july,degrees Celsius,*degree*C*, +temperature_min_08,temperature_min_08,WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Aug,min T Aug,august,degrees Celsius,*degree*C*, +temperature_min_09,temperature_min_09,WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Sep,min T Sep,september,degrees Celsius,*degree*C*, +temperature_min_10,temperature_min_10,WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Oct,min T Oct,october,degrees Celsius,*degree*C*, +temperature_min_11,temperature_min_11,WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Nov,min T Nov,november,degrees Celsius,*degree*C*, +temperature_min_12,temperature_min_12,WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Dec,min T Dec,december,degrees Celsius,*degree*C*, +temperature_max_01,temperature_max_01,WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jan,max T Jan,january,degrees Celsius,*degree*C*, +temperature_max_02,temperature_max_02,WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Feb,max T Feb,february,degrees Celsius,*degree*C*, +temperature_max_03,temperature_max_03,WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Mar,max T Mar,march,degrees Celsius,*degree*C*, +temperature_max_04,temperature_max_04,WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Apr,max T Apr,april,degrees Celsius,*degree*C*, +temperature_max_05,temperature_max_05,WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature May,max T May,may,degrees Celsius,*degree*C*, +temperature_max_06,temperature_max_06,WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jun,max T Jun,june,degrees Celsius,*degree*C*, +temperature_max_07,temperature_max_07,WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jul,max T Jul,july,degrees Celsius,*degree*C*, +temperature_max_08,temperature_max_08,WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Aug,max T Aug,august,degrees Celsius,*degree*C*, +temperature_max_09,temperature_max_09,WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Sep,max T Sep,september,degrees Celsius,*degree*C*, +temperature_max_10,temperature_max_10,WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Oct,max T Oct,october,degrees Celsius,*degree*C*, +temperature_max_11,temperature_max_11,WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Nov,max T Nov,november,degrees Celsius,*degree*C*, +temperature_max_12,temperature_max_12,WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Dec,max T Dec,december,degrees Celsius,*degree*C*, +bio01,bio01,WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual mean temperature,ann. mean T,year,degrees Celsius,*degree*C*, +bio02,bio02,WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean diurnal range,diurn. range,year,degrees Celsius,*degree*C*, +bio03,bio03,WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,isothermality,isothermality,year,,, +bio04,bio04,WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature seasonality,T season.,year,degrees Celsius,*degree*C*, +bio05,bio05,WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature of warmest month,max. T of warmest mo.,year,degrees Celsius,*degree*C*, +bio06,bio06,WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature of coldest month,min. T of coldest mo.,year,degrees Celsius,*degree*C*, +bio07,bio07,WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature annual range (bio05-bio06),T ann. Range,year,degrees Celsius,*degree*C*, +bio08,bio08,WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of wettest quarter,mean T of wettest qtr,year,degrees Celsius,*degree*C*, +bio09,bio09,WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of driest quarter,mean T of driest qtr,year,degrees Celsius,*degree*C*, +bio10,bio10,WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of warmest quarter,mean T of warmest qtr,year,degrees Celsius,*degree*C*, +bio11,bio11,WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of coldest quarter,mean T of coldest qtr,year,degrees Celsius,*degree*C*, +bio12,bio12,WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual precipitation,ann. P,year,mm per year,*mm~yr^-1*, +bio13,bio13,WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest month,P of wettest mo.,year,mm per month,*mm~mo^-1*, +bio14,bio14,WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest month,P of driest mo.,year,mm per month,*mm~mo^-1*, +bio15,bio15,WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation seasonality (coeff var),P season.,year,,, +bio16,bio16,WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest quarter,P of wettest qtr,year,mm per quarter,*mm~qtr^-1*, +bio17,bio17,WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest quarter,P of driest qtr,year,mm per quarter,*mm~qtr^-1*, +bio18,bio18,WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of warmest quarter,P of warmest qtr,year,mm per quarter,*mm~qtr^-1*, +bio19,bio19,WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of coldest quarter,P of coldest qtr,year,mm per quarter,*mm~qtr^-1*, +precipitation_01,precipitation_01,WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jan,P Jan,january,mm per month,*mm~mo^-1*, +precipitation_02,precipitation_02,WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Feb,P Feb,february,mm per month,*mm~mo^-1*, +precipitation_03,precipitation_03,WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Mar,P Mar,march,mm per month,*mm~mo^-1*, +precipitation_04,precipitation_04,WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Apr,P Apr,april,mm per month,*mm~mo^-1*, +precipitation_05,precipitation_05,WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation May,P May,may,mm per month,*mm~mo^-1*, +precipitation_06,precipitation_06,WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jun,P Jun,june,mm per month,*mm~mo^-1*, +precipitation_07,precipitation_07,WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jul,P Jul,july,mm per month,*mm~mo^-1*, +precipitation_08,precipitation_08,WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Aug,P Aug,august,mm per month,*mm~mo^-1*, +precipitation_09,precipitation_09,WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Sep,P Sep,september,mm per month,*mm~mo^-1*, +precipitation_10,precipitation_10,WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Oct,P Oct,october,mm per month,*mm~mo^-1*, +precipitation_11,precipitation_11,WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Nov,P Nov,november,mm per month,*mm~mo^-1*, +precipitation_12,precipitation_12,WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Dec,P Dec,december,mm per month,*mm~mo^-1*, +temperature_min_01,temperature_min_01,WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jan,min T Jan,january,degrees Celsius,*degree*C*, +temperature_min_02,temperature_min_02,WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Feb,min T Feb,february,degrees Celsius,*degree*C*, +temperature_min_03,temperature_min_03,WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Mar,min T Mar,march,degrees Celsius,*degree*C*, +temperature_min_04,temperature_min_04,WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Apr,min T Apr,april,degrees Celsius,*degree*C*, +temperature_min_05,temperature_min_05,WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature May,min T May,may,degrees Celsius,*degree*C*, +temperature_min_06,temperature_min_06,WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jun,min T Jun,june,degrees Celsius,*degree*C*, +temperature_min_07,temperature_min_07,WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jul,min T Jul,july,degrees Celsius,*degree*C*, +temperature_min_08,temperature_min_08,WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Aug,min T Aug,august,degrees Celsius,*degree*C*, +temperature_min_09,temperature_min_09,WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Sep,min T Sep,september,degrees Celsius,*degree*C*, +temperature_min_10,temperature_min_10,WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Oct,min T Oct,october,degrees Celsius,*degree*C*, +temperature_min_11,temperature_min_11,WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Nov,min T Nov,november,degrees Celsius,*degree*C*, +temperature_min_12,temperature_min_12,WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Dec,min T Dec,december,degrees Celsius,*degree*C*, +temperature_max_01,temperature_max_01,WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jan,max T Jan,january,degrees Celsius,*degree*C*, +temperature_max_02,temperature_max_02,WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Feb,max T Feb,february,degrees Celsius,*degree*C*, +temperature_max_03,temperature_max_03,WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Mar,max T Mar,march,degrees Celsius,*degree*C*, +temperature_max_04,temperature_max_04,WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Apr,max T Apr,april,degrees Celsius,*degree*C*, +temperature_max_05,temperature_max_05,WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature May,max T May,may,degrees Celsius,*degree*C*, +temperature_max_06,temperature_max_06,WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jun,max T Jun,june,degrees Celsius,*degree*C*, +temperature_max_07,temperature_max_07,WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jul,max T Jul,july,degrees Celsius,*degree*C*, +temperature_max_08,temperature_max_08,WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Aug,max T Aug,august,degrees Celsius,*degree*C*, +temperature_max_09,temperature_max_09,WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Sep,max T Sep,september,degrees Celsius,*degree*C*, +temperature_max_10,temperature_max_10,WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Oct,max T Oct,october,degrees Celsius,*degree*C*, +temperature_max_11,temperature_max_11,WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Nov,max T Nov,november,degrees Celsius,*degree*C*, +temperature_max_12,temperature_max_12,WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Dec,max T Dec,december,degrees Celsius,*degree*C*, +bio01,bio01,WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual mean temperature,ann. mean T,year,degrees Celsius,*degree*C*, +bio02,bio02,WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean diurnal range,diurn. range,year,degrees Celsius,*degree*C*, +bio03,bio03,WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,isothermality,isothermality,year,,, +bio04,bio04,WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature seasonality,T season.,year,degrees Celsius,*degree*C*, +bio05,bio05,WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature of warmest month,max. T of warmest mo.,year,degrees Celsius,*degree*C*, +bio06,bio06,WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature of coldest month,min. T of coldest mo.,year,degrees Celsius,*degree*C*, +bio07,bio07,WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature annual range (bio05-bio06),T ann. Range,year,degrees Celsius,*degree*C*, +bio08,bio08,WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of wettest quarter,mean T of wettest qtr,year,degrees Celsius,*degree*C*, +bio09,bio09,WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of driest quarter,mean T of driest qtr,year,degrees Celsius,*degree*C*, +bio10,bio10,WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of warmest quarter,mean T of warmest qtr,year,degrees Celsius,*degree*C*, +bio11,bio11,WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of coldest quarter,mean T of coldest qtr,year,degrees Celsius,*degree*C*, +bio12,bio12,WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual precipitation,ann. P,year,mm per year,*mm~yr^-1*, +bio13,bio13,WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest month,P of wettest mo.,year,mm per month,*mm~mo^-1*, +bio14,bio14,WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest month,P of driest mo.,year,mm per month,*mm~mo^-1*, +bio15,bio15,WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation seasonality (coeff var),P season.,year,,, +bio16,bio16,WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest quarter,P of wettest qtr,year,mm per quarter,*mm~qtr^-1*, +bio17,bio17,WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest quarter,P of driest qtr,year,mm per quarter,*mm~qtr^-1*, +bio18,bio18,WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of warmest quarter,P of warmest qtr,year,mm per quarter,*mm~qtr^-1*, +bio19,bio19,WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of coldest quarter,P of coldest qtr,year,mm per quarter,*mm~qtr^-1*, +precipitation_01,precipitation_01,WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jan,P Jan,january,mm per month,*mm~mo^-1*, +precipitation_02,precipitation_02,WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Feb,P Feb,february,mm per month,*mm~mo^-1*, +precipitation_03,precipitation_03,WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Mar,P Mar,march,mm per month,*mm~mo^-1*, +precipitation_04,precipitation_04,WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Apr,P Apr,april,mm per month,*mm~mo^-1*, +precipitation_05,precipitation_05,WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation May,P May,may,mm per month,*mm~mo^-1*, +precipitation_06,precipitation_06,WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jun,P Jun,june,mm per month,*mm~mo^-1*, +precipitation_07,precipitation_07,WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jul,P Jul,july,mm per month,*mm~mo^-1*, +precipitation_08,precipitation_08,WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Aug,P Aug,august,mm per month,*mm~mo^-1*, +precipitation_09,precipitation_09,WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Sep,P Sep,september,mm per month,*mm~mo^-1*, +precipitation_10,precipitation_10,WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Oct,P Oct,october,mm per month,*mm~mo^-1*, +precipitation_11,precipitation_11,WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Nov,P Nov,november,mm per month,*mm~mo^-1*, +precipitation_12,precipitation_12,WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Dec,P Dec,december,mm per month,*mm~mo^-1*, +temperature_min_01,temperature_min_01,WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jan,min T Jan,january,degrees Celsius,*degree*C*, +temperature_min_02,temperature_min_02,WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Feb,min T Feb,february,degrees Celsius,*degree*C*, +temperature_min_03,temperature_min_03,WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Mar,min T Mar,march,degrees Celsius,*degree*C*, +temperature_min_04,temperature_min_04,WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Apr,min T Apr,april,degrees Celsius,*degree*C*, +temperature_min_05,temperature_min_05,WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature May,min T May,may,degrees Celsius,*degree*C*, +temperature_min_06,temperature_min_06,WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jun,min T Jun,june,degrees Celsius,*degree*C*, +temperature_min_07,temperature_min_07,WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jul,min T Jul,july,degrees Celsius,*degree*C*, +temperature_min_08,temperature_min_08,WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Aug,min T Aug,august,degrees Celsius,*degree*C*, +temperature_min_09,temperature_min_09,WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Sep,min T Sep,september,degrees Celsius,*degree*C*, +temperature_min_10,temperature_min_10,WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Oct,min T Oct,october,degrees Celsius,*degree*C*, +temperature_min_11,temperature_min_11,WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Nov,min T Nov,november,degrees Celsius,*degree*C*, +temperature_min_12,temperature_min_12,WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Dec,min T Dec,december,degrees Celsius,*degree*C*, +temperature_max_01,temperature_max_01,WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jan,max T Jan,january,degrees Celsius,*degree*C*, +temperature_max_02,temperature_max_02,WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Feb,max T Feb,february,degrees Celsius,*degree*C*, +temperature_max_03,temperature_max_03,WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Mar,max T Mar,march,degrees Celsius,*degree*C*, +temperature_max_04,temperature_max_04,WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Apr,max T Apr,april,degrees Celsius,*degree*C*, +temperature_max_05,temperature_max_05,WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature May,max T May,may,degrees Celsius,*degree*C*, +temperature_max_06,temperature_max_06,WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jun,max T Jun,june,degrees Celsius,*degree*C*, +temperature_max_07,temperature_max_07,WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jul,max T Jul,july,degrees Celsius,*degree*C*, +temperature_max_08,temperature_max_08,WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Aug,max T Aug,august,degrees Celsius,*degree*C*, +temperature_max_09,temperature_max_09,WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Sep,max T Sep,september,degrees Celsius,*degree*C*, +temperature_max_10,temperature_max_10,WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Oct,max T Oct,october,degrees Celsius,*degree*C*, +temperature_max_11,temperature_max_11,WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Nov,max T Nov,november,degrees Celsius,*degree*C*, +temperature_max_12,temperature_max_12,WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Dec,max T Dec,december,degrees Celsius,*degree*C*, +bio01,bio01,WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual mean temperature,ann. mean T,year,degrees Celsius,*degree*C*, +bio02,bio02,WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean diurnal range,diurn. range,year,degrees Celsius,*degree*C*, +bio03,bio03,WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,isothermality,isothermality,year,,, +bio04,bio04,WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature seasonality,T season.,year,degrees Celsius,*degree*C*, +bio05,bio05,WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature of warmest month,max. T of warmest mo.,year,degrees Celsius,*degree*C*, +bio06,bio06,WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature of coldest month,min. T of coldest mo.,year,degrees Celsius,*degree*C*, +bio07,bio07,WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature annual range (bio05-bio06),T ann. Range,year,degrees Celsius,*degree*C*, +bio08,bio08,WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of wettest quarter,mean T of wettest qtr,year,degrees Celsius,*degree*C*, +bio09,bio09,WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of driest quarter,mean T of driest qtr,year,degrees Celsius,*degree*C*, +bio10,bio10,WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of warmest quarter,mean T of warmest qtr,year,degrees Celsius,*degree*C*, +bio11,bio11,WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of coldest quarter,mean T of coldest qtr,year,degrees Celsius,*degree*C*, +bio12,bio12,WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual precipitation,ann. P,year,mm per year,*mm~yr^-1*, +bio13,bio13,WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest month,P of wettest mo.,year,mm per month,*mm~mo^-1*, +bio14,bio14,WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest month,P of driest mo.,year,mm per month,*mm~mo^-1*, +bio15,bio15,WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation seasonality (coeff var),P season.,year,,, +bio16,bio16,WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest quarter,P of wettest qtr,year,mm per quarter,*mm~qtr^-1*, +bio17,bio17,WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest quarter,P of driest qtr,year,mm per quarter,*mm~qtr^-1*, +bio18,bio18,WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of warmest quarter,P of warmest qtr,year,mm per quarter,*mm~qtr^-1*, +bio19,bio19,WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of coldest quarter,P of coldest qtr,year,mm per quarter,*mm~qtr^-1*, +precipitation_01,precipitation_01,WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jan,P Jan,january,mm per month,*mm~mo^-1*, +precipitation_02,precipitation_02,WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Feb,P Feb,february,mm per month,*mm~mo^-1*, +precipitation_03,precipitation_03,WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Mar,P Mar,march,mm per month,*mm~mo^-1*, +precipitation_04,precipitation_04,WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Apr,P Apr,april,mm per month,*mm~mo^-1*, +precipitation_05,precipitation_05,WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation May,P May,may,mm per month,*mm~mo^-1*, +precipitation_06,precipitation_06,WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jun,P Jun,june,mm per month,*mm~mo^-1*, +precipitation_07,precipitation_07,WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jul,P Jul,july,mm per month,*mm~mo^-1*, +precipitation_08,precipitation_08,WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Aug,P Aug,august,mm per month,*mm~mo^-1*, +precipitation_09,precipitation_09,WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Sep,P Sep,september,mm per month,*mm~mo^-1*, +precipitation_10,precipitation_10,WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Oct,P Oct,october,mm per month,*mm~mo^-1*, +precipitation_11,precipitation_11,WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Nov,P Nov,november,mm per month,*mm~mo^-1*, +precipitation_12,precipitation_12,WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Dec,P Dec,december,mm per month,*mm~mo^-1*, +temperature_min_01,temperature_min_01,WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jan,min T Jan,january,degrees Celsius,*degree*C*, +temperature_min_02,temperature_min_02,WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Feb,min T Feb,february,degrees Celsius,*degree*C*, +temperature_min_03,temperature_min_03,WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Mar,min T Mar,march,degrees Celsius,*degree*C*, +temperature_min_04,temperature_min_04,WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Apr,min T Apr,april,degrees Celsius,*degree*C*, +temperature_min_05,temperature_min_05,WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature May,min T May,may,degrees Celsius,*degree*C*, +temperature_min_06,temperature_min_06,WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jun,min T Jun,june,degrees Celsius,*degree*C*, +temperature_min_07,temperature_min_07,WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jul,min T Jul,july,degrees Celsius,*degree*C*, +temperature_min_08,temperature_min_08,WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Aug,min T Aug,august,degrees Celsius,*degree*C*, +temperature_min_09,temperature_min_09,WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Sep,min T Sep,september,degrees Celsius,*degree*C*, +temperature_min_10,temperature_min_10,WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Oct,min T Oct,october,degrees Celsius,*degree*C*, +temperature_min_11,temperature_min_11,WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Nov,min T Nov,november,degrees Celsius,*degree*C*, +temperature_min_12,temperature_min_12,WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Dec,min T Dec,december,degrees Celsius,*degree*C*, +temperature_max_01,temperature_max_01,WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jan,max T Jan,january,degrees Celsius,*degree*C*, +temperature_max_02,temperature_max_02,WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Feb,max T Feb,february,degrees Celsius,*degree*C*, +temperature_max_03,temperature_max_03,WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Mar,max T Mar,march,degrees Celsius,*degree*C*, +temperature_max_04,temperature_max_04,WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Apr,max T Apr,april,degrees Celsius,*degree*C*, +temperature_max_05,temperature_max_05,WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature May,max T May,may,degrees Celsius,*degree*C*, +temperature_max_06,temperature_max_06,WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jun,max T Jun,june,degrees Celsius,*degree*C*, +temperature_max_07,temperature_max_07,WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jul,max T Jul,july,degrees Celsius,*degree*C*, +temperature_max_08,temperature_max_08,WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Aug,max T Aug,august,degrees Celsius,*degree*C*, +temperature_max_09,temperature_max_09,WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Sep,max T Sep,september,degrees Celsius,*degree*C*, +temperature_max_10,temperature_max_10,WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Oct,max T Oct,october,degrees Celsius,*degree*C*, +temperature_max_11,temperature_max_11,WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Nov,max T Nov,november,degrees Celsius,*degree*C*, +temperature_max_12,temperature_max_12,WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Dec,max T Dec,december,degrees Celsius,*degree*C*, +bio01,bio01,WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual mean temperature,ann. mean T,year,degrees Celsius,*degree*C*, +bio02,bio02,WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean diurnal range,diurn. range,year,degrees Celsius,*degree*C*, +bio03,bio03,WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,isothermality,isothermality,year,,, +bio04,bio04,WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature seasonality,T season.,year,degrees Celsius,*degree*C*, +bio05,bio05,WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature of warmest month,max. T of warmest mo.,year,degrees Celsius,*degree*C*, +bio06,bio06,WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature of coldest month,min. T of coldest mo.,year,degrees Celsius,*degree*C*, +bio07,bio07,WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature annual range (bio05-bio06),T ann. Range,year,degrees Celsius,*degree*C*, +bio08,bio08,WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of wettest quarter,mean T of wettest qtr,year,degrees Celsius,*degree*C*, +bio09,bio09,WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of driest quarter,mean T of driest qtr,year,degrees Celsius,*degree*C*, +bio10,bio10,WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of warmest quarter,mean T of warmest qtr,year,degrees Celsius,*degree*C*, +bio11,bio11,WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of coldest quarter,mean T of coldest qtr,year,degrees Celsius,*degree*C*, +bio12,bio12,WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual precipitation,ann. P,year,mm per year,*mm~yr^-1*, +bio13,bio13,WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest month,P of wettest mo.,year,mm per month,*mm~mo^-1*, +bio14,bio14,WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest month,P of driest mo.,year,mm per month,*mm~mo^-1*, +bio15,bio15,WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation seasonality (coeff var),P season.,year,,, +bio16,bio16,WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest quarter,P of wettest qtr,year,mm per quarter,*mm~qtr^-1*, +bio17,bio17,WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest quarter,P of driest qtr,year,mm per quarter,*mm~qtr^-1*, +bio18,bio18,WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of warmest quarter,P of warmest qtr,year,mm per quarter,*mm~qtr^-1*, +bio19,bio19,WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of coldest quarter,P of coldest qtr,year,mm per quarter,*mm~qtr^-1*, +precipitation_01,precipitation_01,WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jan,P Jan,january,mm per month,*mm~mo^-1*, +precipitation_02,precipitation_02,WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Feb,P Feb,february,mm per month,*mm~mo^-1*, +precipitation_03,precipitation_03,WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Mar,P Mar,march,mm per month,*mm~mo^-1*, +precipitation_04,precipitation_04,WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Apr,P Apr,april,mm per month,*mm~mo^-1*, +precipitation_05,precipitation_05,WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation May,P May,may,mm per month,*mm~mo^-1*, +precipitation_06,precipitation_06,WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jun,P Jun,june,mm per month,*mm~mo^-1*, +precipitation_07,precipitation_07,WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jul,P Jul,july,mm per month,*mm~mo^-1*, +precipitation_08,precipitation_08,WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Aug,P Aug,august,mm per month,*mm~mo^-1*, +precipitation_09,precipitation_09,WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Sep,P Sep,september,mm per month,*mm~mo^-1*, +precipitation_10,precipitation_10,WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Oct,P Oct,october,mm per month,*mm~mo^-1*, +precipitation_11,precipitation_11,WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Nov,P Nov,november,mm per month,*mm~mo^-1*, +precipitation_12,precipitation_12,WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Dec,P Dec,december,mm per month,*mm~mo^-1*, +temperature_min_01,temperature_min_01,WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jan,min T Jan,january,degrees Celsius,*degree*C*, +temperature_min_02,temperature_min_02,WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Feb,min T Feb,february,degrees Celsius,*degree*C*, +temperature_min_03,temperature_min_03,WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Mar,min T Mar,march,degrees Celsius,*degree*C*, +temperature_min_04,temperature_min_04,WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Apr,min T Apr,april,degrees Celsius,*degree*C*, +temperature_min_05,temperature_min_05,WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature May,min T May,may,degrees Celsius,*degree*C*, +temperature_min_06,temperature_min_06,WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jun,min T Jun,june,degrees Celsius,*degree*C*, +temperature_min_07,temperature_min_07,WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jul,min T Jul,july,degrees Celsius,*degree*C*, +temperature_min_08,temperature_min_08,WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Aug,min T Aug,august,degrees Celsius,*degree*C*, +temperature_min_09,temperature_min_09,WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Sep,min T Sep,september,degrees Celsius,*degree*C*, +temperature_min_10,temperature_min_10,WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Oct,min T Oct,october,degrees Celsius,*degree*C*, +temperature_min_11,temperature_min_11,WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Nov,min T Nov,november,degrees Celsius,*degree*C*, +temperature_min_12,temperature_min_12,WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Dec,min T Dec,december,degrees Celsius,*degree*C*, +temperature_max_01,temperature_max_01,WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jan,max T Jan,january,degrees Celsius,*degree*C*, +temperature_max_02,temperature_max_02,WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Feb,max T Feb,february,degrees Celsius,*degree*C*, +temperature_max_03,temperature_max_03,WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Mar,max T Mar,march,degrees Celsius,*degree*C*, +temperature_max_04,temperature_max_04,WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Apr,max T Apr,april,degrees Celsius,*degree*C*, +temperature_max_05,temperature_max_05,WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature May,max T May,may,degrees Celsius,*degree*C*, +temperature_max_06,temperature_max_06,WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jun,max T Jun,june,degrees Celsius,*degree*C*, +temperature_max_07,temperature_max_07,WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jul,max T Jul,july,degrees Celsius,*degree*C*, +temperature_max_08,temperature_max_08,WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Aug,max T Aug,august,degrees Celsius,*degree*C*, +temperature_max_09,temperature_max_09,WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Sep,max T Sep,september,degrees Celsius,*degree*C*, +temperature_max_10,temperature_max_10,WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Oct,max T Oct,october,degrees Celsius,*degree*C*, +temperature_max_11,temperature_max_11,WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Nov,max T Nov,november,degrees Celsius,*degree*C*, +temperature_max_12,temperature_max_12,WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Dec,max T Dec,december,degrees Celsius,*degree*C*, +bio01,bio01,WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual mean temperature,ann. mean T,year,degrees Celsius,*degree*C*, +bio02,bio02,WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean diurnal range,diurn. range,year,degrees Celsius,*degree*C*, +bio03,bio03,WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,isothermality,isothermality,year,,, +bio04,bio04,WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature seasonality,T season.,year,degrees Celsius,*degree*C*, +bio05,bio05,WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature of warmest month,max. T of warmest mo.,year,degrees Celsius,*degree*C*, +bio06,bio06,WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature of coldest month,min. T of coldest mo.,year,degrees Celsius,*degree*C*, +bio07,bio07,WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature annual range (bio05-bio06),T ann. Range,year,degrees Celsius,*degree*C*, +bio08,bio08,WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of wettest quarter,mean T of wettest qtr,year,degrees Celsius,*degree*C*, +bio09,bio09,WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of driest quarter,mean T of driest qtr,year,degrees Celsius,*degree*C*, +bio10,bio10,WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of warmest quarter,mean T of warmest qtr,year,degrees Celsius,*degree*C*, +bio11,bio11,WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of coldest quarter,mean T of coldest qtr,year,degrees Celsius,*degree*C*, +bio12,bio12,WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual precipitation,ann. P,year,mm per year,*mm~yr^-1*, +bio13,bio13,WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest month,P of wettest mo.,year,mm per month,*mm~mo^-1*, +bio14,bio14,WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest month,P of driest mo.,year,mm per month,*mm~mo^-1*, +bio15,bio15,WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation seasonality (coeff var),P season.,year,,, +bio16,bio16,WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest quarter,P of wettest qtr,year,mm per quarter,*mm~qtr^-1*, +bio17,bio17,WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest quarter,P of driest qtr,year,mm per quarter,*mm~qtr^-1*, +bio18,bio18,WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of warmest quarter,P of warmest qtr,year,mm per quarter,*mm~qtr^-1*, +bio19,bio19,WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m,FALSE,WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of coldest quarter,P of coldest qtr,year,mm per quarter,*mm~qtr^-1*, +precipitation_01,precipitation_01,WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jan,P Jan,january,mm per month,*mm~mo^-1*, +precipitation_02,precipitation_02,WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Feb,P Feb,february,mm per month,*mm~mo^-1*, +precipitation_03,precipitation_03,WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Mar,P Mar,march,mm per month,*mm~mo^-1*, +precipitation_04,precipitation_04,WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Apr,P Apr,april,mm per month,*mm~mo^-1*, +precipitation_05,precipitation_05,WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation May,P May,may,mm per month,*mm~mo^-1*, +precipitation_06,precipitation_06,WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jun,P Jun,june,mm per month,*mm~mo^-1*, +precipitation_07,precipitation_07,WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jul,P Jul,july,mm per month,*mm~mo^-1*, +precipitation_08,precipitation_08,WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Aug,P Aug,august,mm per month,*mm~mo^-1*, +precipitation_09,precipitation_09,WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Sep,P Sep,september,mm per month,*mm~mo^-1*, +precipitation_10,precipitation_10,WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Oct,P Oct,october,mm per month,*mm~mo^-1*, +precipitation_11,precipitation_11,WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Nov,P Nov,november,mm per month,*mm~mo^-1*, +precipitation_12,precipitation_12,WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Dec,P Dec,december,mm per month,*mm~mo^-1*, +temperature_min_01,temperature_min_01,WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jan,min T Jan,january,degrees Celsius,*degree*C*, +temperature_min_02,temperature_min_02,WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Feb,min T Feb,february,degrees Celsius,*degree*C*, +temperature_min_03,temperature_min_03,WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Mar,min T Mar,march,degrees Celsius,*degree*C*, +temperature_min_04,temperature_min_04,WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Apr,min T Apr,april,degrees Celsius,*degree*C*, +temperature_min_05,temperature_min_05,WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature May,min T May,may,degrees Celsius,*degree*C*, +temperature_min_06,temperature_min_06,WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jun,min T Jun,june,degrees Celsius,*degree*C*, +temperature_min_07,temperature_min_07,WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jul,min T Jul,july,degrees Celsius,*degree*C*, +temperature_min_08,temperature_min_08,WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Aug,min T Aug,august,degrees Celsius,*degree*C*, +temperature_min_09,temperature_min_09,WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Sep,min T Sep,september,degrees Celsius,*degree*C*, +temperature_min_10,temperature_min_10,WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Oct,min T Oct,october,degrees Celsius,*degree*C*, +temperature_min_11,temperature_min_11,WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Nov,min T Nov,november,degrees Celsius,*degree*C*, +temperature_min_12,temperature_min_12,WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Dec,min T Dec,december,degrees Celsius,*degree*C*, +temperature_max_01,temperature_max_01,WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jan,max T Jan,january,degrees Celsius,*degree*C*, +temperature_max_02,temperature_max_02,WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Feb,max T Feb,february,degrees Celsius,*degree*C*, +temperature_max_03,temperature_max_03,WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Mar,max T Mar,march,degrees Celsius,*degree*C*, +temperature_max_04,temperature_max_04,WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Apr,max T Apr,april,degrees Celsius,*degree*C*, +temperature_max_05,temperature_max_05,WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature May,max T May,may,degrees Celsius,*degree*C*, +temperature_max_06,temperature_max_06,WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jun,max T Jun,june,degrees Celsius,*degree*C*, +temperature_max_07,temperature_max_07,WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jul,max T Jul,july,degrees Celsius,*degree*C*, +temperature_max_08,temperature_max_08,WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Aug,max T Aug,august,degrees Celsius,*degree*C*, +temperature_max_09,temperature_max_09,WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Sep,max T Sep,september,degrees Celsius,*degree*C*, +temperature_max_10,temperature_max_10,WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Oct,max T Oct,october,degrees Celsius,*degree*C*, +temperature_max_11,temperature_max_11,WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Nov,max T Nov,november,degrees Celsius,*degree*C*, +temperature_max_12,temperature_max_12,WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m,TRUE,WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Dec,max T Dec,december,degrees Celsius,*degree*C*, +bio01,bio01,WorldClim_2.1_MIROC6_ssp126_10m,FALSE,WorldClim_2.1_MIROC6_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual mean temperature,ann. mean T,year,degrees Celsius,*degree*C*, +bio02,bio02,WorldClim_2.1_MIROC6_ssp126_10m,FALSE,WorldClim_2.1_MIROC6_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean diurnal range,diurn. range,year,degrees Celsius,*degree*C*, +bio03,bio03,WorldClim_2.1_MIROC6_ssp126_10m,FALSE,WorldClim_2.1_MIROC6_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,isothermality,isothermality,year,,, +bio04,bio04,WorldClim_2.1_MIROC6_ssp126_10m,FALSE,WorldClim_2.1_MIROC6_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature seasonality,T season.,year,degrees Celsius,*degree*C*, +bio05,bio05,WorldClim_2.1_MIROC6_ssp126_10m,FALSE,WorldClim_2.1_MIROC6_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature of warmest month,max. T of warmest mo.,year,degrees Celsius,*degree*C*, +bio06,bio06,WorldClim_2.1_MIROC6_ssp126_10m,FALSE,WorldClim_2.1_MIROC6_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature of coldest month,min. T of coldest mo.,year,degrees Celsius,*degree*C*, +bio07,bio07,WorldClim_2.1_MIROC6_ssp126_10m,FALSE,WorldClim_2.1_MIROC6_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature annual range (bio05-bio06),T ann. Range,year,degrees Celsius,*degree*C*, +bio08,bio08,WorldClim_2.1_MIROC6_ssp126_10m,FALSE,WorldClim_2.1_MIROC6_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of wettest quarter,mean T of wettest qtr,year,degrees Celsius,*degree*C*, +bio09,bio09,WorldClim_2.1_MIROC6_ssp126_10m,FALSE,WorldClim_2.1_MIROC6_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of driest quarter,mean T of driest qtr,year,degrees Celsius,*degree*C*, +bio10,bio10,WorldClim_2.1_MIROC6_ssp126_10m,FALSE,WorldClim_2.1_MIROC6_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of warmest quarter,mean T of warmest qtr,year,degrees Celsius,*degree*C*, +bio11,bio11,WorldClim_2.1_MIROC6_ssp126_10m,FALSE,WorldClim_2.1_MIROC6_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of coldest quarter,mean T of coldest qtr,year,degrees Celsius,*degree*C*, +bio12,bio12,WorldClim_2.1_MIROC6_ssp126_10m,FALSE,WorldClim_2.1_MIROC6_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual precipitation,ann. P,year,mm per year,*mm~yr^-1*, +bio13,bio13,WorldClim_2.1_MIROC6_ssp126_10m,FALSE,WorldClim_2.1_MIROC6_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest month,P of wettest mo.,year,mm per month,*mm~mo^-1*, +bio14,bio14,WorldClim_2.1_MIROC6_ssp126_10m,FALSE,WorldClim_2.1_MIROC6_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest month,P of driest mo.,year,mm per month,*mm~mo^-1*, +bio15,bio15,WorldClim_2.1_MIROC6_ssp126_10m,FALSE,WorldClim_2.1_MIROC6_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation seasonality (coeff var),P season.,year,,, +bio16,bio16,WorldClim_2.1_MIROC6_ssp126_10m,FALSE,WorldClim_2.1_MIROC6_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest quarter,P of wettest qtr,year,mm per quarter,*mm~qtr^-1*, +bio17,bio17,WorldClim_2.1_MIROC6_ssp126_10m,FALSE,WorldClim_2.1_MIROC6_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest quarter,P of driest qtr,year,mm per quarter,*mm~qtr^-1*, +bio18,bio18,WorldClim_2.1_MIROC6_ssp126_10m,FALSE,WorldClim_2.1_MIROC6_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of warmest quarter,P of warmest qtr,year,mm per quarter,*mm~qtr^-1*, +bio19,bio19,WorldClim_2.1_MIROC6_ssp126_10m,FALSE,WorldClim_2.1_MIROC6_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of coldest quarter,P of coldest qtr,year,mm per quarter,*mm~qtr^-1*, +precipitation_01,precipitation_01,WorldClim_2.1_MIROC6_ssp126_10m,TRUE,WorldClim_2.1_MIROC6_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jan,P Jan,january,mm per month,*mm~mo^-1*, +precipitation_02,precipitation_02,WorldClim_2.1_MIROC6_ssp126_10m,TRUE,WorldClim_2.1_MIROC6_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Feb,P Feb,february,mm per month,*mm~mo^-1*, +precipitation_03,precipitation_03,WorldClim_2.1_MIROC6_ssp126_10m,TRUE,WorldClim_2.1_MIROC6_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Mar,P Mar,march,mm per month,*mm~mo^-1*, +precipitation_04,precipitation_04,WorldClim_2.1_MIROC6_ssp126_10m,TRUE,WorldClim_2.1_MIROC6_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Apr,P Apr,april,mm per month,*mm~mo^-1*, +precipitation_05,precipitation_05,WorldClim_2.1_MIROC6_ssp126_10m,TRUE,WorldClim_2.1_MIROC6_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation May,P May,may,mm per month,*mm~mo^-1*, +precipitation_06,precipitation_06,WorldClim_2.1_MIROC6_ssp126_10m,TRUE,WorldClim_2.1_MIROC6_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jun,P Jun,june,mm per month,*mm~mo^-1*, +precipitation_07,precipitation_07,WorldClim_2.1_MIROC6_ssp126_10m,TRUE,WorldClim_2.1_MIROC6_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jul,P Jul,july,mm per month,*mm~mo^-1*, +precipitation_08,precipitation_08,WorldClim_2.1_MIROC6_ssp126_10m,TRUE,WorldClim_2.1_MIROC6_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Aug,P Aug,august,mm per month,*mm~mo^-1*, +precipitation_09,precipitation_09,WorldClim_2.1_MIROC6_ssp126_10m,TRUE,WorldClim_2.1_MIROC6_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Sep,P Sep,september,mm per month,*mm~mo^-1*, +precipitation_10,precipitation_10,WorldClim_2.1_MIROC6_ssp126_10m,TRUE,WorldClim_2.1_MIROC6_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Oct,P Oct,october,mm per month,*mm~mo^-1*, +precipitation_11,precipitation_11,WorldClim_2.1_MIROC6_ssp126_10m,TRUE,WorldClim_2.1_MIROC6_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Nov,P Nov,november,mm per month,*mm~mo^-1*, +precipitation_12,precipitation_12,WorldClim_2.1_MIROC6_ssp126_10m,TRUE,WorldClim_2.1_MIROC6_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Dec,P Dec,december,mm per month,*mm~mo^-1*, +temperature_min_01,temperature_min_01,WorldClim_2.1_MIROC6_ssp126_10m,TRUE,WorldClim_2.1_MIROC6_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jan,min T Jan,january,degrees Celsius,*degree*C*, +temperature_min_02,temperature_min_02,WorldClim_2.1_MIROC6_ssp126_10m,TRUE,WorldClim_2.1_MIROC6_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Feb,min T Feb,february,degrees Celsius,*degree*C*, +temperature_min_03,temperature_min_03,WorldClim_2.1_MIROC6_ssp126_10m,TRUE,WorldClim_2.1_MIROC6_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Mar,min T Mar,march,degrees Celsius,*degree*C*, +temperature_min_04,temperature_min_04,WorldClim_2.1_MIROC6_ssp126_10m,TRUE,WorldClim_2.1_MIROC6_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Apr,min T Apr,april,degrees Celsius,*degree*C*, +temperature_min_05,temperature_min_05,WorldClim_2.1_MIROC6_ssp126_10m,TRUE,WorldClim_2.1_MIROC6_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature May,min T May,may,degrees Celsius,*degree*C*, +temperature_min_06,temperature_min_06,WorldClim_2.1_MIROC6_ssp126_10m,TRUE,WorldClim_2.1_MIROC6_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jun,min T Jun,june,degrees Celsius,*degree*C*, +temperature_min_07,temperature_min_07,WorldClim_2.1_MIROC6_ssp126_10m,TRUE,WorldClim_2.1_MIROC6_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jul,min T Jul,july,degrees Celsius,*degree*C*, +temperature_min_08,temperature_min_08,WorldClim_2.1_MIROC6_ssp126_10m,TRUE,WorldClim_2.1_MIROC6_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Aug,min T Aug,august,degrees Celsius,*degree*C*, +temperature_min_09,temperature_min_09,WorldClim_2.1_MIROC6_ssp126_10m,TRUE,WorldClim_2.1_MIROC6_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Sep,min T Sep,september,degrees Celsius,*degree*C*, +temperature_min_10,temperature_min_10,WorldClim_2.1_MIROC6_ssp126_10m,TRUE,WorldClim_2.1_MIROC6_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Oct,min T Oct,october,degrees Celsius,*degree*C*, +temperature_min_11,temperature_min_11,WorldClim_2.1_MIROC6_ssp126_10m,TRUE,WorldClim_2.1_MIROC6_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Nov,min T Nov,november,degrees Celsius,*degree*C*, +temperature_min_12,temperature_min_12,WorldClim_2.1_MIROC6_ssp126_10m,TRUE,WorldClim_2.1_MIROC6_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Dec,min T Dec,december,degrees Celsius,*degree*C*, +temperature_max_01,temperature_max_01,WorldClim_2.1_MIROC6_ssp126_10m,TRUE,WorldClim_2.1_MIROC6_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jan,max T Jan,january,degrees Celsius,*degree*C*, +temperature_max_02,temperature_max_02,WorldClim_2.1_MIROC6_ssp126_10m,TRUE,WorldClim_2.1_MIROC6_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Feb,max T Feb,february,degrees Celsius,*degree*C*, +temperature_max_03,temperature_max_03,WorldClim_2.1_MIROC6_ssp126_10m,TRUE,WorldClim_2.1_MIROC6_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Mar,max T Mar,march,degrees Celsius,*degree*C*, +temperature_max_04,temperature_max_04,WorldClim_2.1_MIROC6_ssp126_10m,TRUE,WorldClim_2.1_MIROC6_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Apr,max T Apr,april,degrees Celsius,*degree*C*, +temperature_max_05,temperature_max_05,WorldClim_2.1_MIROC6_ssp126_10m,TRUE,WorldClim_2.1_MIROC6_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature May,max T May,may,degrees Celsius,*degree*C*, +temperature_max_06,temperature_max_06,WorldClim_2.1_MIROC6_ssp126_10m,TRUE,WorldClim_2.1_MIROC6_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jun,max T Jun,june,degrees Celsius,*degree*C*, +temperature_max_07,temperature_max_07,WorldClim_2.1_MIROC6_ssp126_10m,TRUE,WorldClim_2.1_MIROC6_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jul,max T Jul,july,degrees Celsius,*degree*C*, +temperature_max_08,temperature_max_08,WorldClim_2.1_MIROC6_ssp126_10m,TRUE,WorldClim_2.1_MIROC6_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Aug,max T Aug,august,degrees Celsius,*degree*C*, +temperature_max_09,temperature_max_09,WorldClim_2.1_MIROC6_ssp126_10m,TRUE,WorldClim_2.1_MIROC6_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Sep,max T Sep,september,degrees Celsius,*degree*C*, +temperature_max_10,temperature_max_10,WorldClim_2.1_MIROC6_ssp126_10m,TRUE,WorldClim_2.1_MIROC6_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Oct,max T Oct,october,degrees Celsius,*degree*C*, +temperature_max_11,temperature_max_11,WorldClim_2.1_MIROC6_ssp126_10m,TRUE,WorldClim_2.1_MIROC6_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Nov,max T Nov,november,degrees Celsius,*degree*C*, +temperature_max_12,temperature_max_12,WorldClim_2.1_MIROC6_ssp126_10m,TRUE,WorldClim_2.1_MIROC6_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Dec,max T Dec,december,degrees Celsius,*degree*C*, +bio01,bio01,WorldClim_2.1_MIROC6_ssp126_5m,FALSE,WorldClim_2.1_MIROC6_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual mean temperature,ann. mean T,year,degrees Celsius,*degree*C*, +bio02,bio02,WorldClim_2.1_MIROC6_ssp126_5m,FALSE,WorldClim_2.1_MIROC6_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean diurnal range,diurn. range,year,degrees Celsius,*degree*C*, +bio03,bio03,WorldClim_2.1_MIROC6_ssp126_5m,FALSE,WorldClim_2.1_MIROC6_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,isothermality,isothermality,year,,, +bio04,bio04,WorldClim_2.1_MIROC6_ssp126_5m,FALSE,WorldClim_2.1_MIROC6_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature seasonality,T season.,year,degrees Celsius,*degree*C*, +bio05,bio05,WorldClim_2.1_MIROC6_ssp126_5m,FALSE,WorldClim_2.1_MIROC6_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature of warmest month,max. T of warmest mo.,year,degrees Celsius,*degree*C*, +bio06,bio06,WorldClim_2.1_MIROC6_ssp126_5m,FALSE,WorldClim_2.1_MIROC6_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature of coldest month,min. T of coldest mo.,year,degrees Celsius,*degree*C*, +bio07,bio07,WorldClim_2.1_MIROC6_ssp126_5m,FALSE,WorldClim_2.1_MIROC6_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature annual range (bio05-bio06),T ann. Range,year,degrees Celsius,*degree*C*, +bio08,bio08,WorldClim_2.1_MIROC6_ssp126_5m,FALSE,WorldClim_2.1_MIROC6_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of wettest quarter,mean T of wettest qtr,year,degrees Celsius,*degree*C*, +bio09,bio09,WorldClim_2.1_MIROC6_ssp126_5m,FALSE,WorldClim_2.1_MIROC6_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of driest quarter,mean T of driest qtr,year,degrees Celsius,*degree*C*, +bio10,bio10,WorldClim_2.1_MIROC6_ssp126_5m,FALSE,WorldClim_2.1_MIROC6_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of warmest quarter,mean T of warmest qtr,year,degrees Celsius,*degree*C*, +bio11,bio11,WorldClim_2.1_MIROC6_ssp126_5m,FALSE,WorldClim_2.1_MIROC6_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of coldest quarter,mean T of coldest qtr,year,degrees Celsius,*degree*C*, +bio12,bio12,WorldClim_2.1_MIROC6_ssp126_5m,FALSE,WorldClim_2.1_MIROC6_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual precipitation,ann. P,year,mm per year,*mm~yr^-1*, +bio13,bio13,WorldClim_2.1_MIROC6_ssp126_5m,FALSE,WorldClim_2.1_MIROC6_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest month,P of wettest mo.,year,mm per month,*mm~mo^-1*, +bio14,bio14,WorldClim_2.1_MIROC6_ssp126_5m,FALSE,WorldClim_2.1_MIROC6_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest month,P of driest mo.,year,mm per month,*mm~mo^-1*, +bio15,bio15,WorldClim_2.1_MIROC6_ssp126_5m,FALSE,WorldClim_2.1_MIROC6_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation seasonality (coeff var),P season.,year,,, +bio16,bio16,WorldClim_2.1_MIROC6_ssp126_5m,FALSE,WorldClim_2.1_MIROC6_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest quarter,P of wettest qtr,year,mm per quarter,*mm~qtr^-1*, +bio17,bio17,WorldClim_2.1_MIROC6_ssp126_5m,FALSE,WorldClim_2.1_MIROC6_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest quarter,P of driest qtr,year,mm per quarter,*mm~qtr^-1*, +bio18,bio18,WorldClim_2.1_MIROC6_ssp126_5m,FALSE,WorldClim_2.1_MIROC6_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of warmest quarter,P of warmest qtr,year,mm per quarter,*mm~qtr^-1*, +bio19,bio19,WorldClim_2.1_MIROC6_ssp126_5m,FALSE,WorldClim_2.1_MIROC6_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of coldest quarter,P of coldest qtr,year,mm per quarter,*mm~qtr^-1*, +precipitation_01,precipitation_01,WorldClim_2.1_MIROC6_ssp126_5m,TRUE,WorldClim_2.1_MIROC6_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jan,P Jan,january,mm per month,*mm~mo^-1*, +precipitation_02,precipitation_02,WorldClim_2.1_MIROC6_ssp126_5m,TRUE,WorldClim_2.1_MIROC6_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Feb,P Feb,february,mm per month,*mm~mo^-1*, +precipitation_03,precipitation_03,WorldClim_2.1_MIROC6_ssp126_5m,TRUE,WorldClim_2.1_MIROC6_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Mar,P Mar,march,mm per month,*mm~mo^-1*, +precipitation_04,precipitation_04,WorldClim_2.1_MIROC6_ssp126_5m,TRUE,WorldClim_2.1_MIROC6_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Apr,P Apr,april,mm per month,*mm~mo^-1*, +precipitation_05,precipitation_05,WorldClim_2.1_MIROC6_ssp126_5m,TRUE,WorldClim_2.1_MIROC6_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation May,P May,may,mm per month,*mm~mo^-1*, +precipitation_06,precipitation_06,WorldClim_2.1_MIROC6_ssp126_5m,TRUE,WorldClim_2.1_MIROC6_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jun,P Jun,june,mm per month,*mm~mo^-1*, +precipitation_07,precipitation_07,WorldClim_2.1_MIROC6_ssp126_5m,TRUE,WorldClim_2.1_MIROC6_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jul,P Jul,july,mm per month,*mm~mo^-1*, +precipitation_08,precipitation_08,WorldClim_2.1_MIROC6_ssp126_5m,TRUE,WorldClim_2.1_MIROC6_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Aug,P Aug,august,mm per month,*mm~mo^-1*, +precipitation_09,precipitation_09,WorldClim_2.1_MIROC6_ssp126_5m,TRUE,WorldClim_2.1_MIROC6_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Sep,P Sep,september,mm per month,*mm~mo^-1*, +precipitation_10,precipitation_10,WorldClim_2.1_MIROC6_ssp126_5m,TRUE,WorldClim_2.1_MIROC6_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Oct,P Oct,october,mm per month,*mm~mo^-1*, +precipitation_11,precipitation_11,WorldClim_2.1_MIROC6_ssp126_5m,TRUE,WorldClim_2.1_MIROC6_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Nov,P Nov,november,mm per month,*mm~mo^-1*, +precipitation_12,precipitation_12,WorldClim_2.1_MIROC6_ssp126_5m,TRUE,WorldClim_2.1_MIROC6_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Dec,P Dec,december,mm per month,*mm~mo^-1*, +temperature_min_01,temperature_min_01,WorldClim_2.1_MIROC6_ssp126_5m,TRUE,WorldClim_2.1_MIROC6_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jan,min T Jan,january,degrees Celsius,*degree*C*, +temperature_min_02,temperature_min_02,WorldClim_2.1_MIROC6_ssp126_5m,TRUE,WorldClim_2.1_MIROC6_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Feb,min T Feb,february,degrees Celsius,*degree*C*, +temperature_min_03,temperature_min_03,WorldClim_2.1_MIROC6_ssp126_5m,TRUE,WorldClim_2.1_MIROC6_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Mar,min T Mar,march,degrees Celsius,*degree*C*, +temperature_min_04,temperature_min_04,WorldClim_2.1_MIROC6_ssp126_5m,TRUE,WorldClim_2.1_MIROC6_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Apr,min T Apr,april,degrees Celsius,*degree*C*, +temperature_min_05,temperature_min_05,WorldClim_2.1_MIROC6_ssp126_5m,TRUE,WorldClim_2.1_MIROC6_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature May,min T May,may,degrees Celsius,*degree*C*, +temperature_min_06,temperature_min_06,WorldClim_2.1_MIROC6_ssp126_5m,TRUE,WorldClim_2.1_MIROC6_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jun,min T Jun,june,degrees Celsius,*degree*C*, +temperature_min_07,temperature_min_07,WorldClim_2.1_MIROC6_ssp126_5m,TRUE,WorldClim_2.1_MIROC6_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jul,min T Jul,july,degrees Celsius,*degree*C*, +temperature_min_08,temperature_min_08,WorldClim_2.1_MIROC6_ssp126_5m,TRUE,WorldClim_2.1_MIROC6_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Aug,min T Aug,august,degrees Celsius,*degree*C*, +temperature_min_09,temperature_min_09,WorldClim_2.1_MIROC6_ssp126_5m,TRUE,WorldClim_2.1_MIROC6_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Sep,min T Sep,september,degrees Celsius,*degree*C*, +temperature_min_10,temperature_min_10,WorldClim_2.1_MIROC6_ssp126_5m,TRUE,WorldClim_2.1_MIROC6_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Oct,min T Oct,october,degrees Celsius,*degree*C*, +temperature_min_11,temperature_min_11,WorldClim_2.1_MIROC6_ssp126_5m,TRUE,WorldClim_2.1_MIROC6_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Nov,min T Nov,november,degrees Celsius,*degree*C*, +temperature_min_12,temperature_min_12,WorldClim_2.1_MIROC6_ssp126_5m,TRUE,WorldClim_2.1_MIROC6_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Dec,min T Dec,december,degrees Celsius,*degree*C*, +temperature_max_01,temperature_max_01,WorldClim_2.1_MIROC6_ssp126_5m,TRUE,WorldClim_2.1_MIROC6_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jan,max T Jan,january,degrees Celsius,*degree*C*, +temperature_max_02,temperature_max_02,WorldClim_2.1_MIROC6_ssp126_5m,TRUE,WorldClim_2.1_MIROC6_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Feb,max T Feb,february,degrees Celsius,*degree*C*, +temperature_max_03,temperature_max_03,WorldClim_2.1_MIROC6_ssp126_5m,TRUE,WorldClim_2.1_MIROC6_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Mar,max T Mar,march,degrees Celsius,*degree*C*, +temperature_max_04,temperature_max_04,WorldClim_2.1_MIROC6_ssp126_5m,TRUE,WorldClim_2.1_MIROC6_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Apr,max T Apr,april,degrees Celsius,*degree*C*, +temperature_max_05,temperature_max_05,WorldClim_2.1_MIROC6_ssp126_5m,TRUE,WorldClim_2.1_MIROC6_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature May,max T May,may,degrees Celsius,*degree*C*, +temperature_max_06,temperature_max_06,WorldClim_2.1_MIROC6_ssp126_5m,TRUE,WorldClim_2.1_MIROC6_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jun,max T Jun,june,degrees Celsius,*degree*C*, +temperature_max_07,temperature_max_07,WorldClim_2.1_MIROC6_ssp126_5m,TRUE,WorldClim_2.1_MIROC6_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jul,max T Jul,july,degrees Celsius,*degree*C*, +temperature_max_08,temperature_max_08,WorldClim_2.1_MIROC6_ssp126_5m,TRUE,WorldClim_2.1_MIROC6_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Aug,max T Aug,august,degrees Celsius,*degree*C*, +temperature_max_09,temperature_max_09,WorldClim_2.1_MIROC6_ssp126_5m,TRUE,WorldClim_2.1_MIROC6_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Sep,max T Sep,september,degrees Celsius,*degree*C*, +temperature_max_10,temperature_max_10,WorldClim_2.1_MIROC6_ssp126_5m,TRUE,WorldClim_2.1_MIROC6_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Oct,max T Oct,october,degrees Celsius,*degree*C*, +temperature_max_11,temperature_max_11,WorldClim_2.1_MIROC6_ssp126_5m,TRUE,WorldClim_2.1_MIROC6_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Nov,max T Nov,november,degrees Celsius,*degree*C*, +temperature_max_12,temperature_max_12,WorldClim_2.1_MIROC6_ssp126_5m,TRUE,WorldClim_2.1_MIROC6_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Dec,max T Dec,december,degrees Celsius,*degree*C*, +bio01,bio01,WorldClim_2.1_MIROC6_ssp245_10m,FALSE,WorldClim_2.1_MIROC6_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual mean temperature,ann. mean T,year,degrees Celsius,*degree*C*, +bio02,bio02,WorldClim_2.1_MIROC6_ssp245_10m,FALSE,WorldClim_2.1_MIROC6_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean diurnal range,diurn. range,year,degrees Celsius,*degree*C*, +bio03,bio03,WorldClim_2.1_MIROC6_ssp245_10m,FALSE,WorldClim_2.1_MIROC6_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,isothermality,isothermality,year,,, +bio04,bio04,WorldClim_2.1_MIROC6_ssp245_10m,FALSE,WorldClim_2.1_MIROC6_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature seasonality,T season.,year,degrees Celsius,*degree*C*, +bio05,bio05,WorldClim_2.1_MIROC6_ssp245_10m,FALSE,WorldClim_2.1_MIROC6_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature of warmest month,max. T of warmest mo.,year,degrees Celsius,*degree*C*, +bio06,bio06,WorldClim_2.1_MIROC6_ssp245_10m,FALSE,WorldClim_2.1_MIROC6_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature of coldest month,min. T of coldest mo.,year,degrees Celsius,*degree*C*, +bio07,bio07,WorldClim_2.1_MIROC6_ssp245_10m,FALSE,WorldClim_2.1_MIROC6_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature annual range (bio05-bio06),T ann. Range,year,degrees Celsius,*degree*C*, +bio08,bio08,WorldClim_2.1_MIROC6_ssp245_10m,FALSE,WorldClim_2.1_MIROC6_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of wettest quarter,mean T of wettest qtr,year,degrees Celsius,*degree*C*, +bio09,bio09,WorldClim_2.1_MIROC6_ssp245_10m,FALSE,WorldClim_2.1_MIROC6_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of driest quarter,mean T of driest qtr,year,degrees Celsius,*degree*C*, +bio10,bio10,WorldClim_2.1_MIROC6_ssp245_10m,FALSE,WorldClim_2.1_MIROC6_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of warmest quarter,mean T of warmest qtr,year,degrees Celsius,*degree*C*, +bio11,bio11,WorldClim_2.1_MIROC6_ssp245_10m,FALSE,WorldClim_2.1_MIROC6_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of coldest quarter,mean T of coldest qtr,year,degrees Celsius,*degree*C*, +bio12,bio12,WorldClim_2.1_MIROC6_ssp245_10m,FALSE,WorldClim_2.1_MIROC6_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual precipitation,ann. P,year,mm per year,*mm~yr^-1*, +bio13,bio13,WorldClim_2.1_MIROC6_ssp245_10m,FALSE,WorldClim_2.1_MIROC6_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest month,P of wettest mo.,year,mm per month,*mm~mo^-1*, +bio14,bio14,WorldClim_2.1_MIROC6_ssp245_10m,FALSE,WorldClim_2.1_MIROC6_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest month,P of driest mo.,year,mm per month,*mm~mo^-1*, +bio15,bio15,WorldClim_2.1_MIROC6_ssp245_10m,FALSE,WorldClim_2.1_MIROC6_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation seasonality (coeff var),P season.,year,,, +bio16,bio16,WorldClim_2.1_MIROC6_ssp245_10m,FALSE,WorldClim_2.1_MIROC6_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest quarter,P of wettest qtr,year,mm per quarter,*mm~qtr^-1*, +bio17,bio17,WorldClim_2.1_MIROC6_ssp245_10m,FALSE,WorldClim_2.1_MIROC6_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest quarter,P of driest qtr,year,mm per quarter,*mm~qtr^-1*, +bio18,bio18,WorldClim_2.1_MIROC6_ssp245_10m,FALSE,WorldClim_2.1_MIROC6_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of warmest quarter,P of warmest qtr,year,mm per quarter,*mm~qtr^-1*, +bio19,bio19,WorldClim_2.1_MIROC6_ssp245_10m,FALSE,WorldClim_2.1_MIROC6_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of coldest quarter,P of coldest qtr,year,mm per quarter,*mm~qtr^-1*, +precipitation_01,precipitation_01,WorldClim_2.1_MIROC6_ssp245_10m,TRUE,WorldClim_2.1_MIROC6_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jan,P Jan,january,mm per month,*mm~mo^-1*, +precipitation_02,precipitation_02,WorldClim_2.1_MIROC6_ssp245_10m,TRUE,WorldClim_2.1_MIROC6_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Feb,P Feb,february,mm per month,*mm~mo^-1*, +precipitation_03,precipitation_03,WorldClim_2.1_MIROC6_ssp245_10m,TRUE,WorldClim_2.1_MIROC6_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Mar,P Mar,march,mm per month,*mm~mo^-1*, +precipitation_04,precipitation_04,WorldClim_2.1_MIROC6_ssp245_10m,TRUE,WorldClim_2.1_MIROC6_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Apr,P Apr,april,mm per month,*mm~mo^-1*, +precipitation_05,precipitation_05,WorldClim_2.1_MIROC6_ssp245_10m,TRUE,WorldClim_2.1_MIROC6_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation May,P May,may,mm per month,*mm~mo^-1*, +precipitation_06,precipitation_06,WorldClim_2.1_MIROC6_ssp245_10m,TRUE,WorldClim_2.1_MIROC6_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jun,P Jun,june,mm per month,*mm~mo^-1*, +precipitation_07,precipitation_07,WorldClim_2.1_MIROC6_ssp245_10m,TRUE,WorldClim_2.1_MIROC6_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jul,P Jul,july,mm per month,*mm~mo^-1*, +precipitation_08,precipitation_08,WorldClim_2.1_MIROC6_ssp245_10m,TRUE,WorldClim_2.1_MIROC6_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Aug,P Aug,august,mm per month,*mm~mo^-1*, +precipitation_09,precipitation_09,WorldClim_2.1_MIROC6_ssp245_10m,TRUE,WorldClim_2.1_MIROC6_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Sep,P Sep,september,mm per month,*mm~mo^-1*, +precipitation_10,precipitation_10,WorldClim_2.1_MIROC6_ssp245_10m,TRUE,WorldClim_2.1_MIROC6_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Oct,P Oct,october,mm per month,*mm~mo^-1*, +precipitation_11,precipitation_11,WorldClim_2.1_MIROC6_ssp245_10m,TRUE,WorldClim_2.1_MIROC6_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Nov,P Nov,november,mm per month,*mm~mo^-1*, +precipitation_12,precipitation_12,WorldClim_2.1_MIROC6_ssp245_10m,TRUE,WorldClim_2.1_MIROC6_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Dec,P Dec,december,mm per month,*mm~mo^-1*, +temperature_min_01,temperature_min_01,WorldClim_2.1_MIROC6_ssp245_10m,TRUE,WorldClim_2.1_MIROC6_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jan,min T Jan,january,degrees Celsius,*degree*C*, +temperature_min_02,temperature_min_02,WorldClim_2.1_MIROC6_ssp245_10m,TRUE,WorldClim_2.1_MIROC6_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Feb,min T Feb,february,degrees Celsius,*degree*C*, +temperature_min_03,temperature_min_03,WorldClim_2.1_MIROC6_ssp245_10m,TRUE,WorldClim_2.1_MIROC6_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Mar,min T Mar,march,degrees Celsius,*degree*C*, +temperature_min_04,temperature_min_04,WorldClim_2.1_MIROC6_ssp245_10m,TRUE,WorldClim_2.1_MIROC6_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Apr,min T Apr,april,degrees Celsius,*degree*C*, +temperature_min_05,temperature_min_05,WorldClim_2.1_MIROC6_ssp245_10m,TRUE,WorldClim_2.1_MIROC6_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature May,min T May,may,degrees Celsius,*degree*C*, +temperature_min_06,temperature_min_06,WorldClim_2.1_MIROC6_ssp245_10m,TRUE,WorldClim_2.1_MIROC6_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jun,min T Jun,june,degrees Celsius,*degree*C*, +temperature_min_07,temperature_min_07,WorldClim_2.1_MIROC6_ssp245_10m,TRUE,WorldClim_2.1_MIROC6_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jul,min T Jul,july,degrees Celsius,*degree*C*, +temperature_min_08,temperature_min_08,WorldClim_2.1_MIROC6_ssp245_10m,TRUE,WorldClim_2.1_MIROC6_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Aug,min T Aug,august,degrees Celsius,*degree*C*, +temperature_min_09,temperature_min_09,WorldClim_2.1_MIROC6_ssp245_10m,TRUE,WorldClim_2.1_MIROC6_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Sep,min T Sep,september,degrees Celsius,*degree*C*, +temperature_min_10,temperature_min_10,WorldClim_2.1_MIROC6_ssp245_10m,TRUE,WorldClim_2.1_MIROC6_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Oct,min T Oct,october,degrees Celsius,*degree*C*, +temperature_min_11,temperature_min_11,WorldClim_2.1_MIROC6_ssp245_10m,TRUE,WorldClim_2.1_MIROC6_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Nov,min T Nov,november,degrees Celsius,*degree*C*, +temperature_min_12,temperature_min_12,WorldClim_2.1_MIROC6_ssp245_10m,TRUE,WorldClim_2.1_MIROC6_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Dec,min T Dec,december,degrees Celsius,*degree*C*, +temperature_max_01,temperature_max_01,WorldClim_2.1_MIROC6_ssp245_10m,TRUE,WorldClim_2.1_MIROC6_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jan,max T Jan,january,degrees Celsius,*degree*C*, +temperature_max_02,temperature_max_02,WorldClim_2.1_MIROC6_ssp245_10m,TRUE,WorldClim_2.1_MIROC6_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Feb,max T Feb,february,degrees Celsius,*degree*C*, +temperature_max_03,temperature_max_03,WorldClim_2.1_MIROC6_ssp245_10m,TRUE,WorldClim_2.1_MIROC6_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Mar,max T Mar,march,degrees Celsius,*degree*C*, +temperature_max_04,temperature_max_04,WorldClim_2.1_MIROC6_ssp245_10m,TRUE,WorldClim_2.1_MIROC6_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Apr,max T Apr,april,degrees Celsius,*degree*C*, +temperature_max_05,temperature_max_05,WorldClim_2.1_MIROC6_ssp245_10m,TRUE,WorldClim_2.1_MIROC6_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature May,max T May,may,degrees Celsius,*degree*C*, +temperature_max_06,temperature_max_06,WorldClim_2.1_MIROC6_ssp245_10m,TRUE,WorldClim_2.1_MIROC6_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jun,max T Jun,june,degrees Celsius,*degree*C*, +temperature_max_07,temperature_max_07,WorldClim_2.1_MIROC6_ssp245_10m,TRUE,WorldClim_2.1_MIROC6_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jul,max T Jul,july,degrees Celsius,*degree*C*, +temperature_max_08,temperature_max_08,WorldClim_2.1_MIROC6_ssp245_10m,TRUE,WorldClim_2.1_MIROC6_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Aug,max T Aug,august,degrees Celsius,*degree*C*, +temperature_max_09,temperature_max_09,WorldClim_2.1_MIROC6_ssp245_10m,TRUE,WorldClim_2.1_MIROC6_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Sep,max T Sep,september,degrees Celsius,*degree*C*, +temperature_max_10,temperature_max_10,WorldClim_2.1_MIROC6_ssp245_10m,TRUE,WorldClim_2.1_MIROC6_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Oct,max T Oct,october,degrees Celsius,*degree*C*, +temperature_max_11,temperature_max_11,WorldClim_2.1_MIROC6_ssp245_10m,TRUE,WorldClim_2.1_MIROC6_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Nov,max T Nov,november,degrees Celsius,*degree*C*, +temperature_max_12,temperature_max_12,WorldClim_2.1_MIROC6_ssp245_10m,TRUE,WorldClim_2.1_MIROC6_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Dec,max T Dec,december,degrees Celsius,*degree*C*, +bio01,bio01,WorldClim_2.1_MIROC6_ssp245_5m,FALSE,WorldClim_2.1_MIROC6_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual mean temperature,ann. mean T,year,degrees Celsius,*degree*C*, +bio02,bio02,WorldClim_2.1_MIROC6_ssp245_5m,FALSE,WorldClim_2.1_MIROC6_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean diurnal range,diurn. range,year,degrees Celsius,*degree*C*, +bio03,bio03,WorldClim_2.1_MIROC6_ssp245_5m,FALSE,WorldClim_2.1_MIROC6_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,isothermality,isothermality,year,,, +bio04,bio04,WorldClim_2.1_MIROC6_ssp245_5m,FALSE,WorldClim_2.1_MIROC6_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature seasonality,T season.,year,degrees Celsius,*degree*C*, +bio05,bio05,WorldClim_2.1_MIROC6_ssp245_5m,FALSE,WorldClim_2.1_MIROC6_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature of warmest month,max. T of warmest mo.,year,degrees Celsius,*degree*C*, +bio06,bio06,WorldClim_2.1_MIROC6_ssp245_5m,FALSE,WorldClim_2.1_MIROC6_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature of coldest month,min. T of coldest mo.,year,degrees Celsius,*degree*C*, +bio07,bio07,WorldClim_2.1_MIROC6_ssp245_5m,FALSE,WorldClim_2.1_MIROC6_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature annual range (bio05-bio06),T ann. Range,year,degrees Celsius,*degree*C*, +bio08,bio08,WorldClim_2.1_MIROC6_ssp245_5m,FALSE,WorldClim_2.1_MIROC6_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of wettest quarter,mean T of wettest qtr,year,degrees Celsius,*degree*C*, +bio09,bio09,WorldClim_2.1_MIROC6_ssp245_5m,FALSE,WorldClim_2.1_MIROC6_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of driest quarter,mean T of driest qtr,year,degrees Celsius,*degree*C*, +bio10,bio10,WorldClim_2.1_MIROC6_ssp245_5m,FALSE,WorldClim_2.1_MIROC6_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of warmest quarter,mean T of warmest qtr,year,degrees Celsius,*degree*C*, +bio11,bio11,WorldClim_2.1_MIROC6_ssp245_5m,FALSE,WorldClim_2.1_MIROC6_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of coldest quarter,mean T of coldest qtr,year,degrees Celsius,*degree*C*, +bio12,bio12,WorldClim_2.1_MIROC6_ssp245_5m,FALSE,WorldClim_2.1_MIROC6_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual precipitation,ann. P,year,mm per year,*mm~yr^-1*, +bio13,bio13,WorldClim_2.1_MIROC6_ssp245_5m,FALSE,WorldClim_2.1_MIROC6_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest month,P of wettest mo.,year,mm per month,*mm~mo^-1*, +bio14,bio14,WorldClim_2.1_MIROC6_ssp245_5m,FALSE,WorldClim_2.1_MIROC6_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest month,P of driest mo.,year,mm per month,*mm~mo^-1*, +bio15,bio15,WorldClim_2.1_MIROC6_ssp245_5m,FALSE,WorldClim_2.1_MIROC6_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation seasonality (coeff var),P season.,year,,, +bio16,bio16,WorldClim_2.1_MIROC6_ssp245_5m,FALSE,WorldClim_2.1_MIROC6_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest quarter,P of wettest qtr,year,mm per quarter,*mm~qtr^-1*, +bio17,bio17,WorldClim_2.1_MIROC6_ssp245_5m,FALSE,WorldClim_2.1_MIROC6_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest quarter,P of driest qtr,year,mm per quarter,*mm~qtr^-1*, +bio18,bio18,WorldClim_2.1_MIROC6_ssp245_5m,FALSE,WorldClim_2.1_MIROC6_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of warmest quarter,P of warmest qtr,year,mm per quarter,*mm~qtr^-1*, +bio19,bio19,WorldClim_2.1_MIROC6_ssp245_5m,FALSE,WorldClim_2.1_MIROC6_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of coldest quarter,P of coldest qtr,year,mm per quarter,*mm~qtr^-1*, +precipitation_01,precipitation_01,WorldClim_2.1_MIROC6_ssp245_5m,TRUE,WorldClim_2.1_MIROC6_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jan,P Jan,january,mm per month,*mm~mo^-1*, +precipitation_02,precipitation_02,WorldClim_2.1_MIROC6_ssp245_5m,TRUE,WorldClim_2.1_MIROC6_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Feb,P Feb,february,mm per month,*mm~mo^-1*, +precipitation_03,precipitation_03,WorldClim_2.1_MIROC6_ssp245_5m,TRUE,WorldClim_2.1_MIROC6_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Mar,P Mar,march,mm per month,*mm~mo^-1*, +precipitation_04,precipitation_04,WorldClim_2.1_MIROC6_ssp245_5m,TRUE,WorldClim_2.1_MIROC6_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Apr,P Apr,april,mm per month,*mm~mo^-1*, +precipitation_05,precipitation_05,WorldClim_2.1_MIROC6_ssp245_5m,TRUE,WorldClim_2.1_MIROC6_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation May,P May,may,mm per month,*mm~mo^-1*, +precipitation_06,precipitation_06,WorldClim_2.1_MIROC6_ssp245_5m,TRUE,WorldClim_2.1_MIROC6_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jun,P Jun,june,mm per month,*mm~mo^-1*, +precipitation_07,precipitation_07,WorldClim_2.1_MIROC6_ssp245_5m,TRUE,WorldClim_2.1_MIROC6_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jul,P Jul,july,mm per month,*mm~mo^-1*, +precipitation_08,precipitation_08,WorldClim_2.1_MIROC6_ssp245_5m,TRUE,WorldClim_2.1_MIROC6_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Aug,P Aug,august,mm per month,*mm~mo^-1*, +precipitation_09,precipitation_09,WorldClim_2.1_MIROC6_ssp245_5m,TRUE,WorldClim_2.1_MIROC6_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Sep,P Sep,september,mm per month,*mm~mo^-1*, +precipitation_10,precipitation_10,WorldClim_2.1_MIROC6_ssp245_5m,TRUE,WorldClim_2.1_MIROC6_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Oct,P Oct,october,mm per month,*mm~mo^-1*, +precipitation_11,precipitation_11,WorldClim_2.1_MIROC6_ssp245_5m,TRUE,WorldClim_2.1_MIROC6_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Nov,P Nov,november,mm per month,*mm~mo^-1*, +precipitation_12,precipitation_12,WorldClim_2.1_MIROC6_ssp245_5m,TRUE,WorldClim_2.1_MIROC6_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Dec,P Dec,december,mm per month,*mm~mo^-1*, +temperature_min_01,temperature_min_01,WorldClim_2.1_MIROC6_ssp245_5m,TRUE,WorldClim_2.1_MIROC6_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jan,min T Jan,january,degrees Celsius,*degree*C*, +temperature_min_02,temperature_min_02,WorldClim_2.1_MIROC6_ssp245_5m,TRUE,WorldClim_2.1_MIROC6_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Feb,min T Feb,february,degrees Celsius,*degree*C*, +temperature_min_03,temperature_min_03,WorldClim_2.1_MIROC6_ssp245_5m,TRUE,WorldClim_2.1_MIROC6_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Mar,min T Mar,march,degrees Celsius,*degree*C*, +temperature_min_04,temperature_min_04,WorldClim_2.1_MIROC6_ssp245_5m,TRUE,WorldClim_2.1_MIROC6_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Apr,min T Apr,april,degrees Celsius,*degree*C*, +temperature_min_05,temperature_min_05,WorldClim_2.1_MIROC6_ssp245_5m,TRUE,WorldClim_2.1_MIROC6_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature May,min T May,may,degrees Celsius,*degree*C*, +temperature_min_06,temperature_min_06,WorldClim_2.1_MIROC6_ssp245_5m,TRUE,WorldClim_2.1_MIROC6_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jun,min T Jun,june,degrees Celsius,*degree*C*, +temperature_min_07,temperature_min_07,WorldClim_2.1_MIROC6_ssp245_5m,TRUE,WorldClim_2.1_MIROC6_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jul,min T Jul,july,degrees Celsius,*degree*C*, +temperature_min_08,temperature_min_08,WorldClim_2.1_MIROC6_ssp245_5m,TRUE,WorldClim_2.1_MIROC6_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Aug,min T Aug,august,degrees Celsius,*degree*C*, +temperature_min_09,temperature_min_09,WorldClim_2.1_MIROC6_ssp245_5m,TRUE,WorldClim_2.1_MIROC6_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Sep,min T Sep,september,degrees Celsius,*degree*C*, +temperature_min_10,temperature_min_10,WorldClim_2.1_MIROC6_ssp245_5m,TRUE,WorldClim_2.1_MIROC6_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Oct,min T Oct,october,degrees Celsius,*degree*C*, +temperature_min_11,temperature_min_11,WorldClim_2.1_MIROC6_ssp245_5m,TRUE,WorldClim_2.1_MIROC6_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Nov,min T Nov,november,degrees Celsius,*degree*C*, +temperature_min_12,temperature_min_12,WorldClim_2.1_MIROC6_ssp245_5m,TRUE,WorldClim_2.1_MIROC6_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Dec,min T Dec,december,degrees Celsius,*degree*C*, +temperature_max_01,temperature_max_01,WorldClim_2.1_MIROC6_ssp245_5m,TRUE,WorldClim_2.1_MIROC6_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jan,max T Jan,january,degrees Celsius,*degree*C*, +temperature_max_02,temperature_max_02,WorldClim_2.1_MIROC6_ssp245_5m,TRUE,WorldClim_2.1_MIROC6_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Feb,max T Feb,february,degrees Celsius,*degree*C*, +temperature_max_03,temperature_max_03,WorldClim_2.1_MIROC6_ssp245_5m,TRUE,WorldClim_2.1_MIROC6_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Mar,max T Mar,march,degrees Celsius,*degree*C*, +temperature_max_04,temperature_max_04,WorldClim_2.1_MIROC6_ssp245_5m,TRUE,WorldClim_2.1_MIROC6_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Apr,max T Apr,april,degrees Celsius,*degree*C*, +temperature_max_05,temperature_max_05,WorldClim_2.1_MIROC6_ssp245_5m,TRUE,WorldClim_2.1_MIROC6_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature May,max T May,may,degrees Celsius,*degree*C*, +temperature_max_06,temperature_max_06,WorldClim_2.1_MIROC6_ssp245_5m,TRUE,WorldClim_2.1_MIROC6_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jun,max T Jun,june,degrees Celsius,*degree*C*, +temperature_max_07,temperature_max_07,WorldClim_2.1_MIROC6_ssp245_5m,TRUE,WorldClim_2.1_MIROC6_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jul,max T Jul,july,degrees Celsius,*degree*C*, +temperature_max_08,temperature_max_08,WorldClim_2.1_MIROC6_ssp245_5m,TRUE,WorldClim_2.1_MIROC6_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Aug,max T Aug,august,degrees Celsius,*degree*C*, +temperature_max_09,temperature_max_09,WorldClim_2.1_MIROC6_ssp245_5m,TRUE,WorldClim_2.1_MIROC6_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Sep,max T Sep,september,degrees Celsius,*degree*C*, +temperature_max_10,temperature_max_10,WorldClim_2.1_MIROC6_ssp245_5m,TRUE,WorldClim_2.1_MIROC6_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Oct,max T Oct,october,degrees Celsius,*degree*C*, +temperature_max_11,temperature_max_11,WorldClim_2.1_MIROC6_ssp245_5m,TRUE,WorldClim_2.1_MIROC6_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Nov,max T Nov,november,degrees Celsius,*degree*C*, +temperature_max_12,temperature_max_12,WorldClim_2.1_MIROC6_ssp245_5m,TRUE,WorldClim_2.1_MIROC6_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Dec,max T Dec,december,degrees Celsius,*degree*C*, +bio01,bio01,WorldClim_2.1_MIROC6_ssp370_10m,FALSE,WorldClim_2.1_MIROC6_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual mean temperature,ann. mean T,year,degrees Celsius,*degree*C*, +bio02,bio02,WorldClim_2.1_MIROC6_ssp370_10m,FALSE,WorldClim_2.1_MIROC6_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean diurnal range,diurn. range,year,degrees Celsius,*degree*C*, +bio03,bio03,WorldClim_2.1_MIROC6_ssp370_10m,FALSE,WorldClim_2.1_MIROC6_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,isothermality,isothermality,year,,, +bio04,bio04,WorldClim_2.1_MIROC6_ssp370_10m,FALSE,WorldClim_2.1_MIROC6_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature seasonality,T season.,year,degrees Celsius,*degree*C*, +bio05,bio05,WorldClim_2.1_MIROC6_ssp370_10m,FALSE,WorldClim_2.1_MIROC6_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature of warmest month,max. T of warmest mo.,year,degrees Celsius,*degree*C*, +bio06,bio06,WorldClim_2.1_MIROC6_ssp370_10m,FALSE,WorldClim_2.1_MIROC6_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature of coldest month,min. T of coldest mo.,year,degrees Celsius,*degree*C*, +bio07,bio07,WorldClim_2.1_MIROC6_ssp370_10m,FALSE,WorldClim_2.1_MIROC6_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature annual range (bio05-bio06),T ann. Range,year,degrees Celsius,*degree*C*, +bio08,bio08,WorldClim_2.1_MIROC6_ssp370_10m,FALSE,WorldClim_2.1_MIROC6_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of wettest quarter,mean T of wettest qtr,year,degrees Celsius,*degree*C*, +bio09,bio09,WorldClim_2.1_MIROC6_ssp370_10m,FALSE,WorldClim_2.1_MIROC6_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of driest quarter,mean T of driest qtr,year,degrees Celsius,*degree*C*, +bio10,bio10,WorldClim_2.1_MIROC6_ssp370_10m,FALSE,WorldClim_2.1_MIROC6_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of warmest quarter,mean T of warmest qtr,year,degrees Celsius,*degree*C*, +bio11,bio11,WorldClim_2.1_MIROC6_ssp370_10m,FALSE,WorldClim_2.1_MIROC6_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of coldest quarter,mean T of coldest qtr,year,degrees Celsius,*degree*C*, +bio12,bio12,WorldClim_2.1_MIROC6_ssp370_10m,FALSE,WorldClim_2.1_MIROC6_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual precipitation,ann. P,year,mm per year,*mm~yr^-1*, +bio13,bio13,WorldClim_2.1_MIROC6_ssp370_10m,FALSE,WorldClim_2.1_MIROC6_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest month,P of wettest mo.,year,mm per month,*mm~mo^-1*, +bio14,bio14,WorldClim_2.1_MIROC6_ssp370_10m,FALSE,WorldClim_2.1_MIROC6_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest month,P of driest mo.,year,mm per month,*mm~mo^-1*, +bio15,bio15,WorldClim_2.1_MIROC6_ssp370_10m,FALSE,WorldClim_2.1_MIROC6_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation seasonality (coeff var),P season.,year,,, +bio16,bio16,WorldClim_2.1_MIROC6_ssp370_10m,FALSE,WorldClim_2.1_MIROC6_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest quarter,P of wettest qtr,year,mm per quarter,*mm~qtr^-1*, +bio17,bio17,WorldClim_2.1_MIROC6_ssp370_10m,FALSE,WorldClim_2.1_MIROC6_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest quarter,P of driest qtr,year,mm per quarter,*mm~qtr^-1*, +bio18,bio18,WorldClim_2.1_MIROC6_ssp370_10m,FALSE,WorldClim_2.1_MIROC6_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of warmest quarter,P of warmest qtr,year,mm per quarter,*mm~qtr^-1*, +bio19,bio19,WorldClim_2.1_MIROC6_ssp370_10m,FALSE,WorldClim_2.1_MIROC6_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of coldest quarter,P of coldest qtr,year,mm per quarter,*mm~qtr^-1*, +precipitation_01,precipitation_01,WorldClim_2.1_MIROC6_ssp370_10m,TRUE,WorldClim_2.1_MIROC6_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jan,P Jan,january,mm per month,*mm~mo^-1*, +precipitation_02,precipitation_02,WorldClim_2.1_MIROC6_ssp370_10m,TRUE,WorldClim_2.1_MIROC6_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Feb,P Feb,february,mm per month,*mm~mo^-1*, +precipitation_03,precipitation_03,WorldClim_2.1_MIROC6_ssp370_10m,TRUE,WorldClim_2.1_MIROC6_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Mar,P Mar,march,mm per month,*mm~mo^-1*, +precipitation_04,precipitation_04,WorldClim_2.1_MIROC6_ssp370_10m,TRUE,WorldClim_2.1_MIROC6_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Apr,P Apr,april,mm per month,*mm~mo^-1*, +precipitation_05,precipitation_05,WorldClim_2.1_MIROC6_ssp370_10m,TRUE,WorldClim_2.1_MIROC6_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation May,P May,may,mm per month,*mm~mo^-1*, +precipitation_06,precipitation_06,WorldClim_2.1_MIROC6_ssp370_10m,TRUE,WorldClim_2.1_MIROC6_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jun,P Jun,june,mm per month,*mm~mo^-1*, +precipitation_07,precipitation_07,WorldClim_2.1_MIROC6_ssp370_10m,TRUE,WorldClim_2.1_MIROC6_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jul,P Jul,july,mm per month,*mm~mo^-1*, +precipitation_08,precipitation_08,WorldClim_2.1_MIROC6_ssp370_10m,TRUE,WorldClim_2.1_MIROC6_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Aug,P Aug,august,mm per month,*mm~mo^-1*, +precipitation_09,precipitation_09,WorldClim_2.1_MIROC6_ssp370_10m,TRUE,WorldClim_2.1_MIROC6_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Sep,P Sep,september,mm per month,*mm~mo^-1*, +precipitation_10,precipitation_10,WorldClim_2.1_MIROC6_ssp370_10m,TRUE,WorldClim_2.1_MIROC6_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Oct,P Oct,october,mm per month,*mm~mo^-1*, +precipitation_11,precipitation_11,WorldClim_2.1_MIROC6_ssp370_10m,TRUE,WorldClim_2.1_MIROC6_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Nov,P Nov,november,mm per month,*mm~mo^-1*, +precipitation_12,precipitation_12,WorldClim_2.1_MIROC6_ssp370_10m,TRUE,WorldClim_2.1_MIROC6_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Dec,P Dec,december,mm per month,*mm~mo^-1*, +temperature_min_01,temperature_min_01,WorldClim_2.1_MIROC6_ssp370_10m,TRUE,WorldClim_2.1_MIROC6_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jan,min T Jan,january,degrees Celsius,*degree*C*, +temperature_min_02,temperature_min_02,WorldClim_2.1_MIROC6_ssp370_10m,TRUE,WorldClim_2.1_MIROC6_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Feb,min T Feb,february,degrees Celsius,*degree*C*, +temperature_min_03,temperature_min_03,WorldClim_2.1_MIROC6_ssp370_10m,TRUE,WorldClim_2.1_MIROC6_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Mar,min T Mar,march,degrees Celsius,*degree*C*, +temperature_min_04,temperature_min_04,WorldClim_2.1_MIROC6_ssp370_10m,TRUE,WorldClim_2.1_MIROC6_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Apr,min T Apr,april,degrees Celsius,*degree*C*, +temperature_min_05,temperature_min_05,WorldClim_2.1_MIROC6_ssp370_10m,TRUE,WorldClim_2.1_MIROC6_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature May,min T May,may,degrees Celsius,*degree*C*, +temperature_min_06,temperature_min_06,WorldClim_2.1_MIROC6_ssp370_10m,TRUE,WorldClim_2.1_MIROC6_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jun,min T Jun,june,degrees Celsius,*degree*C*, +temperature_min_07,temperature_min_07,WorldClim_2.1_MIROC6_ssp370_10m,TRUE,WorldClim_2.1_MIROC6_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jul,min T Jul,july,degrees Celsius,*degree*C*, +temperature_min_08,temperature_min_08,WorldClim_2.1_MIROC6_ssp370_10m,TRUE,WorldClim_2.1_MIROC6_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Aug,min T Aug,august,degrees Celsius,*degree*C*, +temperature_min_09,temperature_min_09,WorldClim_2.1_MIROC6_ssp370_10m,TRUE,WorldClim_2.1_MIROC6_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Sep,min T Sep,september,degrees Celsius,*degree*C*, +temperature_min_10,temperature_min_10,WorldClim_2.1_MIROC6_ssp370_10m,TRUE,WorldClim_2.1_MIROC6_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Oct,min T Oct,october,degrees Celsius,*degree*C*, +temperature_min_11,temperature_min_11,WorldClim_2.1_MIROC6_ssp370_10m,TRUE,WorldClim_2.1_MIROC6_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Nov,min T Nov,november,degrees Celsius,*degree*C*, +temperature_min_12,temperature_min_12,WorldClim_2.1_MIROC6_ssp370_10m,TRUE,WorldClim_2.1_MIROC6_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Dec,min T Dec,december,degrees Celsius,*degree*C*, +temperature_max_01,temperature_max_01,WorldClim_2.1_MIROC6_ssp370_10m,TRUE,WorldClim_2.1_MIROC6_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jan,max T Jan,january,degrees Celsius,*degree*C*, +temperature_max_02,temperature_max_02,WorldClim_2.1_MIROC6_ssp370_10m,TRUE,WorldClim_2.1_MIROC6_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Feb,max T Feb,february,degrees Celsius,*degree*C*, +temperature_max_03,temperature_max_03,WorldClim_2.1_MIROC6_ssp370_10m,TRUE,WorldClim_2.1_MIROC6_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Mar,max T Mar,march,degrees Celsius,*degree*C*, +temperature_max_04,temperature_max_04,WorldClim_2.1_MIROC6_ssp370_10m,TRUE,WorldClim_2.1_MIROC6_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Apr,max T Apr,april,degrees Celsius,*degree*C*, +temperature_max_05,temperature_max_05,WorldClim_2.1_MIROC6_ssp370_10m,TRUE,WorldClim_2.1_MIROC6_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature May,max T May,may,degrees Celsius,*degree*C*, +temperature_max_06,temperature_max_06,WorldClim_2.1_MIROC6_ssp370_10m,TRUE,WorldClim_2.1_MIROC6_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jun,max T Jun,june,degrees Celsius,*degree*C*, +temperature_max_07,temperature_max_07,WorldClim_2.1_MIROC6_ssp370_10m,TRUE,WorldClim_2.1_MIROC6_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jul,max T Jul,july,degrees Celsius,*degree*C*, +temperature_max_08,temperature_max_08,WorldClim_2.1_MIROC6_ssp370_10m,TRUE,WorldClim_2.1_MIROC6_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Aug,max T Aug,august,degrees Celsius,*degree*C*, +temperature_max_09,temperature_max_09,WorldClim_2.1_MIROC6_ssp370_10m,TRUE,WorldClim_2.1_MIROC6_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Sep,max T Sep,september,degrees Celsius,*degree*C*, +temperature_max_10,temperature_max_10,WorldClim_2.1_MIROC6_ssp370_10m,TRUE,WorldClim_2.1_MIROC6_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Oct,max T Oct,october,degrees Celsius,*degree*C*, +temperature_max_11,temperature_max_11,WorldClim_2.1_MIROC6_ssp370_10m,TRUE,WorldClim_2.1_MIROC6_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Nov,max T Nov,november,degrees Celsius,*degree*C*, +temperature_max_12,temperature_max_12,WorldClim_2.1_MIROC6_ssp370_10m,TRUE,WorldClim_2.1_MIROC6_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Dec,max T Dec,december,degrees Celsius,*degree*C*, +bio01,bio01,WorldClim_2.1_MIROC6_ssp370_5m,FALSE,WorldClim_2.1_MIROC6_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual mean temperature,ann. mean T,year,degrees Celsius,*degree*C*, +bio02,bio02,WorldClim_2.1_MIROC6_ssp370_5m,FALSE,WorldClim_2.1_MIROC6_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean diurnal range,diurn. range,year,degrees Celsius,*degree*C*, +bio03,bio03,WorldClim_2.1_MIROC6_ssp370_5m,FALSE,WorldClim_2.1_MIROC6_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,isothermality,isothermality,year,,, +bio04,bio04,WorldClim_2.1_MIROC6_ssp370_5m,FALSE,WorldClim_2.1_MIROC6_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature seasonality,T season.,year,degrees Celsius,*degree*C*, +bio05,bio05,WorldClim_2.1_MIROC6_ssp370_5m,FALSE,WorldClim_2.1_MIROC6_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature of warmest month,max. T of warmest mo.,year,degrees Celsius,*degree*C*, +bio06,bio06,WorldClim_2.1_MIROC6_ssp370_5m,FALSE,WorldClim_2.1_MIROC6_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature of coldest month,min. T of coldest mo.,year,degrees Celsius,*degree*C*, +bio07,bio07,WorldClim_2.1_MIROC6_ssp370_5m,FALSE,WorldClim_2.1_MIROC6_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature annual range (bio05-bio06),T ann. Range,year,degrees Celsius,*degree*C*, +bio08,bio08,WorldClim_2.1_MIROC6_ssp370_5m,FALSE,WorldClim_2.1_MIROC6_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of wettest quarter,mean T of wettest qtr,year,degrees Celsius,*degree*C*, +bio09,bio09,WorldClim_2.1_MIROC6_ssp370_5m,FALSE,WorldClim_2.1_MIROC6_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of driest quarter,mean T of driest qtr,year,degrees Celsius,*degree*C*, +bio10,bio10,WorldClim_2.1_MIROC6_ssp370_5m,FALSE,WorldClim_2.1_MIROC6_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of warmest quarter,mean T of warmest qtr,year,degrees Celsius,*degree*C*, +bio11,bio11,WorldClim_2.1_MIROC6_ssp370_5m,FALSE,WorldClim_2.1_MIROC6_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of coldest quarter,mean T of coldest qtr,year,degrees Celsius,*degree*C*, +bio12,bio12,WorldClim_2.1_MIROC6_ssp370_5m,FALSE,WorldClim_2.1_MIROC6_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual precipitation,ann. P,year,mm per year,*mm~yr^-1*, +bio13,bio13,WorldClim_2.1_MIROC6_ssp370_5m,FALSE,WorldClim_2.1_MIROC6_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest month,P of wettest mo.,year,mm per month,*mm~mo^-1*, +bio14,bio14,WorldClim_2.1_MIROC6_ssp370_5m,FALSE,WorldClim_2.1_MIROC6_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest month,P of driest mo.,year,mm per month,*mm~mo^-1*, +bio15,bio15,WorldClim_2.1_MIROC6_ssp370_5m,FALSE,WorldClim_2.1_MIROC6_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation seasonality (coeff var),P season.,year,,, +bio16,bio16,WorldClim_2.1_MIROC6_ssp370_5m,FALSE,WorldClim_2.1_MIROC6_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest quarter,P of wettest qtr,year,mm per quarter,*mm~qtr^-1*, +bio17,bio17,WorldClim_2.1_MIROC6_ssp370_5m,FALSE,WorldClim_2.1_MIROC6_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest quarter,P of driest qtr,year,mm per quarter,*mm~qtr^-1*, +bio18,bio18,WorldClim_2.1_MIROC6_ssp370_5m,FALSE,WorldClim_2.1_MIROC6_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of warmest quarter,P of warmest qtr,year,mm per quarter,*mm~qtr^-1*, +bio19,bio19,WorldClim_2.1_MIROC6_ssp370_5m,FALSE,WorldClim_2.1_MIROC6_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of coldest quarter,P of coldest qtr,year,mm per quarter,*mm~qtr^-1*, +precipitation_01,precipitation_01,WorldClim_2.1_MIROC6_ssp370_5m,TRUE,WorldClim_2.1_MIROC6_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jan,P Jan,january,mm per month,*mm~mo^-1*, +precipitation_02,precipitation_02,WorldClim_2.1_MIROC6_ssp370_5m,TRUE,WorldClim_2.1_MIROC6_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Feb,P Feb,february,mm per month,*mm~mo^-1*, +precipitation_03,precipitation_03,WorldClim_2.1_MIROC6_ssp370_5m,TRUE,WorldClim_2.1_MIROC6_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Mar,P Mar,march,mm per month,*mm~mo^-1*, +precipitation_04,precipitation_04,WorldClim_2.1_MIROC6_ssp370_5m,TRUE,WorldClim_2.1_MIROC6_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Apr,P Apr,april,mm per month,*mm~mo^-1*, +precipitation_05,precipitation_05,WorldClim_2.1_MIROC6_ssp370_5m,TRUE,WorldClim_2.1_MIROC6_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation May,P May,may,mm per month,*mm~mo^-1*, +precipitation_06,precipitation_06,WorldClim_2.1_MIROC6_ssp370_5m,TRUE,WorldClim_2.1_MIROC6_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jun,P Jun,june,mm per month,*mm~mo^-1*, +precipitation_07,precipitation_07,WorldClim_2.1_MIROC6_ssp370_5m,TRUE,WorldClim_2.1_MIROC6_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jul,P Jul,july,mm per month,*mm~mo^-1*, +precipitation_08,precipitation_08,WorldClim_2.1_MIROC6_ssp370_5m,TRUE,WorldClim_2.1_MIROC6_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Aug,P Aug,august,mm per month,*mm~mo^-1*, +precipitation_09,precipitation_09,WorldClim_2.1_MIROC6_ssp370_5m,TRUE,WorldClim_2.1_MIROC6_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Sep,P Sep,september,mm per month,*mm~mo^-1*, +precipitation_10,precipitation_10,WorldClim_2.1_MIROC6_ssp370_5m,TRUE,WorldClim_2.1_MIROC6_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Oct,P Oct,october,mm per month,*mm~mo^-1*, +precipitation_11,precipitation_11,WorldClim_2.1_MIROC6_ssp370_5m,TRUE,WorldClim_2.1_MIROC6_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Nov,P Nov,november,mm per month,*mm~mo^-1*, +precipitation_12,precipitation_12,WorldClim_2.1_MIROC6_ssp370_5m,TRUE,WorldClim_2.1_MIROC6_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Dec,P Dec,december,mm per month,*mm~mo^-1*, +temperature_min_01,temperature_min_01,WorldClim_2.1_MIROC6_ssp370_5m,TRUE,WorldClim_2.1_MIROC6_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jan,min T Jan,january,degrees Celsius,*degree*C*, +temperature_min_02,temperature_min_02,WorldClim_2.1_MIROC6_ssp370_5m,TRUE,WorldClim_2.1_MIROC6_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Feb,min T Feb,february,degrees Celsius,*degree*C*, +temperature_min_03,temperature_min_03,WorldClim_2.1_MIROC6_ssp370_5m,TRUE,WorldClim_2.1_MIROC6_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Mar,min T Mar,march,degrees Celsius,*degree*C*, +temperature_min_04,temperature_min_04,WorldClim_2.1_MIROC6_ssp370_5m,TRUE,WorldClim_2.1_MIROC6_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Apr,min T Apr,april,degrees Celsius,*degree*C*, +temperature_min_05,temperature_min_05,WorldClim_2.1_MIROC6_ssp370_5m,TRUE,WorldClim_2.1_MIROC6_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature May,min T May,may,degrees Celsius,*degree*C*, +temperature_min_06,temperature_min_06,WorldClim_2.1_MIROC6_ssp370_5m,TRUE,WorldClim_2.1_MIROC6_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jun,min T Jun,june,degrees Celsius,*degree*C*, +temperature_min_07,temperature_min_07,WorldClim_2.1_MIROC6_ssp370_5m,TRUE,WorldClim_2.1_MIROC6_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jul,min T Jul,july,degrees Celsius,*degree*C*, +temperature_min_08,temperature_min_08,WorldClim_2.1_MIROC6_ssp370_5m,TRUE,WorldClim_2.1_MIROC6_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Aug,min T Aug,august,degrees Celsius,*degree*C*, +temperature_min_09,temperature_min_09,WorldClim_2.1_MIROC6_ssp370_5m,TRUE,WorldClim_2.1_MIROC6_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Sep,min T Sep,september,degrees Celsius,*degree*C*, +temperature_min_10,temperature_min_10,WorldClim_2.1_MIROC6_ssp370_5m,TRUE,WorldClim_2.1_MIROC6_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Oct,min T Oct,october,degrees Celsius,*degree*C*, +temperature_min_11,temperature_min_11,WorldClim_2.1_MIROC6_ssp370_5m,TRUE,WorldClim_2.1_MIROC6_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Nov,min T Nov,november,degrees Celsius,*degree*C*, +temperature_min_12,temperature_min_12,WorldClim_2.1_MIROC6_ssp370_5m,TRUE,WorldClim_2.1_MIROC6_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Dec,min T Dec,december,degrees Celsius,*degree*C*, +temperature_max_01,temperature_max_01,WorldClim_2.1_MIROC6_ssp370_5m,TRUE,WorldClim_2.1_MIROC6_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jan,max T Jan,january,degrees Celsius,*degree*C*, +temperature_max_02,temperature_max_02,WorldClim_2.1_MIROC6_ssp370_5m,TRUE,WorldClim_2.1_MIROC6_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Feb,max T Feb,february,degrees Celsius,*degree*C*, +temperature_max_03,temperature_max_03,WorldClim_2.1_MIROC6_ssp370_5m,TRUE,WorldClim_2.1_MIROC6_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Mar,max T Mar,march,degrees Celsius,*degree*C*, +temperature_max_04,temperature_max_04,WorldClim_2.1_MIROC6_ssp370_5m,TRUE,WorldClim_2.1_MIROC6_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Apr,max T Apr,april,degrees Celsius,*degree*C*, +temperature_max_05,temperature_max_05,WorldClim_2.1_MIROC6_ssp370_5m,TRUE,WorldClim_2.1_MIROC6_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature May,max T May,may,degrees Celsius,*degree*C*, +temperature_max_06,temperature_max_06,WorldClim_2.1_MIROC6_ssp370_5m,TRUE,WorldClim_2.1_MIROC6_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jun,max T Jun,june,degrees Celsius,*degree*C*, +temperature_max_07,temperature_max_07,WorldClim_2.1_MIROC6_ssp370_5m,TRUE,WorldClim_2.1_MIROC6_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jul,max T Jul,july,degrees Celsius,*degree*C*, +temperature_max_08,temperature_max_08,WorldClim_2.1_MIROC6_ssp370_5m,TRUE,WorldClim_2.1_MIROC6_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Aug,max T Aug,august,degrees Celsius,*degree*C*, +temperature_max_09,temperature_max_09,WorldClim_2.1_MIROC6_ssp370_5m,TRUE,WorldClim_2.1_MIROC6_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Sep,max T Sep,september,degrees Celsius,*degree*C*, +temperature_max_10,temperature_max_10,WorldClim_2.1_MIROC6_ssp370_5m,TRUE,WorldClim_2.1_MIROC6_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Oct,max T Oct,october,degrees Celsius,*degree*C*, +temperature_max_11,temperature_max_11,WorldClim_2.1_MIROC6_ssp370_5m,TRUE,WorldClim_2.1_MIROC6_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Nov,max T Nov,november,degrees Celsius,*degree*C*, +temperature_max_12,temperature_max_12,WorldClim_2.1_MIROC6_ssp370_5m,TRUE,WorldClim_2.1_MIROC6_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Dec,max T Dec,december,degrees Celsius,*degree*C*, +bio01,bio01,WorldClim_2.1_MIROC6_ssp585_10m,FALSE,WorldClim_2.1_MIROC6_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual mean temperature,ann. mean T,year,degrees Celsius,*degree*C*, +bio02,bio02,WorldClim_2.1_MIROC6_ssp585_10m,FALSE,WorldClim_2.1_MIROC6_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean diurnal range,diurn. range,year,degrees Celsius,*degree*C*, +bio03,bio03,WorldClim_2.1_MIROC6_ssp585_10m,FALSE,WorldClim_2.1_MIROC6_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,isothermality,isothermality,year,,, +bio04,bio04,WorldClim_2.1_MIROC6_ssp585_10m,FALSE,WorldClim_2.1_MIROC6_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature seasonality,T season.,year,degrees Celsius,*degree*C*, +bio05,bio05,WorldClim_2.1_MIROC6_ssp585_10m,FALSE,WorldClim_2.1_MIROC6_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature of warmest month,max. T of warmest mo.,year,degrees Celsius,*degree*C*, +bio06,bio06,WorldClim_2.1_MIROC6_ssp585_10m,FALSE,WorldClim_2.1_MIROC6_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature of coldest month,min. T of coldest mo.,year,degrees Celsius,*degree*C*, +bio07,bio07,WorldClim_2.1_MIROC6_ssp585_10m,FALSE,WorldClim_2.1_MIROC6_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature annual range (bio05-bio06),T ann. Range,year,degrees Celsius,*degree*C*, +bio08,bio08,WorldClim_2.1_MIROC6_ssp585_10m,FALSE,WorldClim_2.1_MIROC6_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of wettest quarter,mean T of wettest qtr,year,degrees Celsius,*degree*C*, +bio09,bio09,WorldClim_2.1_MIROC6_ssp585_10m,FALSE,WorldClim_2.1_MIROC6_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of driest quarter,mean T of driest qtr,year,degrees Celsius,*degree*C*, +bio10,bio10,WorldClim_2.1_MIROC6_ssp585_10m,FALSE,WorldClim_2.1_MIROC6_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of warmest quarter,mean T of warmest qtr,year,degrees Celsius,*degree*C*, +bio11,bio11,WorldClim_2.1_MIROC6_ssp585_10m,FALSE,WorldClim_2.1_MIROC6_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of coldest quarter,mean T of coldest qtr,year,degrees Celsius,*degree*C*, +bio12,bio12,WorldClim_2.1_MIROC6_ssp585_10m,FALSE,WorldClim_2.1_MIROC6_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual precipitation,ann. P,year,mm per year,*mm~yr^-1*, +bio13,bio13,WorldClim_2.1_MIROC6_ssp585_10m,FALSE,WorldClim_2.1_MIROC6_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest month,P of wettest mo.,year,mm per month,*mm~mo^-1*, +bio14,bio14,WorldClim_2.1_MIROC6_ssp585_10m,FALSE,WorldClim_2.1_MIROC6_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest month,P of driest mo.,year,mm per month,*mm~mo^-1*, +bio15,bio15,WorldClim_2.1_MIROC6_ssp585_10m,FALSE,WorldClim_2.1_MIROC6_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation seasonality (coeff var),P season.,year,,, +bio16,bio16,WorldClim_2.1_MIROC6_ssp585_10m,FALSE,WorldClim_2.1_MIROC6_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest quarter,P of wettest qtr,year,mm per quarter,*mm~qtr^-1*, +bio17,bio17,WorldClim_2.1_MIROC6_ssp585_10m,FALSE,WorldClim_2.1_MIROC6_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest quarter,P of driest qtr,year,mm per quarter,*mm~qtr^-1*, +bio18,bio18,WorldClim_2.1_MIROC6_ssp585_10m,FALSE,WorldClim_2.1_MIROC6_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of warmest quarter,P of warmest qtr,year,mm per quarter,*mm~qtr^-1*, +bio19,bio19,WorldClim_2.1_MIROC6_ssp585_10m,FALSE,WorldClim_2.1_MIROC6_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of coldest quarter,P of coldest qtr,year,mm per quarter,*mm~qtr^-1*, +precipitation_01,precipitation_01,WorldClim_2.1_MIROC6_ssp585_10m,TRUE,WorldClim_2.1_MIROC6_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jan,P Jan,january,mm per month,*mm~mo^-1*, +precipitation_02,precipitation_02,WorldClim_2.1_MIROC6_ssp585_10m,TRUE,WorldClim_2.1_MIROC6_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Feb,P Feb,february,mm per month,*mm~mo^-1*, +precipitation_03,precipitation_03,WorldClim_2.1_MIROC6_ssp585_10m,TRUE,WorldClim_2.1_MIROC6_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Mar,P Mar,march,mm per month,*mm~mo^-1*, +precipitation_04,precipitation_04,WorldClim_2.1_MIROC6_ssp585_10m,TRUE,WorldClim_2.1_MIROC6_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Apr,P Apr,april,mm per month,*mm~mo^-1*, +precipitation_05,precipitation_05,WorldClim_2.1_MIROC6_ssp585_10m,TRUE,WorldClim_2.1_MIROC6_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation May,P May,may,mm per month,*mm~mo^-1*, +precipitation_06,precipitation_06,WorldClim_2.1_MIROC6_ssp585_10m,TRUE,WorldClim_2.1_MIROC6_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jun,P Jun,june,mm per month,*mm~mo^-1*, +precipitation_07,precipitation_07,WorldClim_2.1_MIROC6_ssp585_10m,TRUE,WorldClim_2.1_MIROC6_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jul,P Jul,july,mm per month,*mm~mo^-1*, +precipitation_08,precipitation_08,WorldClim_2.1_MIROC6_ssp585_10m,TRUE,WorldClim_2.1_MIROC6_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Aug,P Aug,august,mm per month,*mm~mo^-1*, +precipitation_09,precipitation_09,WorldClim_2.1_MIROC6_ssp585_10m,TRUE,WorldClim_2.1_MIROC6_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Sep,P Sep,september,mm per month,*mm~mo^-1*, +precipitation_10,precipitation_10,WorldClim_2.1_MIROC6_ssp585_10m,TRUE,WorldClim_2.1_MIROC6_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Oct,P Oct,october,mm per month,*mm~mo^-1*, +precipitation_11,precipitation_11,WorldClim_2.1_MIROC6_ssp585_10m,TRUE,WorldClim_2.1_MIROC6_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Nov,P Nov,november,mm per month,*mm~mo^-1*, +precipitation_12,precipitation_12,WorldClim_2.1_MIROC6_ssp585_10m,TRUE,WorldClim_2.1_MIROC6_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Dec,P Dec,december,mm per month,*mm~mo^-1*, +temperature_min_01,temperature_min_01,WorldClim_2.1_MIROC6_ssp585_10m,TRUE,WorldClim_2.1_MIROC6_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jan,min T Jan,january,degrees Celsius,*degree*C*, +temperature_min_02,temperature_min_02,WorldClim_2.1_MIROC6_ssp585_10m,TRUE,WorldClim_2.1_MIROC6_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Feb,min T Feb,february,degrees Celsius,*degree*C*, +temperature_min_03,temperature_min_03,WorldClim_2.1_MIROC6_ssp585_10m,TRUE,WorldClim_2.1_MIROC6_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Mar,min T Mar,march,degrees Celsius,*degree*C*, +temperature_min_04,temperature_min_04,WorldClim_2.1_MIROC6_ssp585_10m,TRUE,WorldClim_2.1_MIROC6_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Apr,min T Apr,april,degrees Celsius,*degree*C*, +temperature_min_05,temperature_min_05,WorldClim_2.1_MIROC6_ssp585_10m,TRUE,WorldClim_2.1_MIROC6_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature May,min T May,may,degrees Celsius,*degree*C*, +temperature_min_06,temperature_min_06,WorldClim_2.1_MIROC6_ssp585_10m,TRUE,WorldClim_2.1_MIROC6_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jun,min T Jun,june,degrees Celsius,*degree*C*, +temperature_min_07,temperature_min_07,WorldClim_2.1_MIROC6_ssp585_10m,TRUE,WorldClim_2.1_MIROC6_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jul,min T Jul,july,degrees Celsius,*degree*C*, +temperature_min_08,temperature_min_08,WorldClim_2.1_MIROC6_ssp585_10m,TRUE,WorldClim_2.1_MIROC6_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Aug,min T Aug,august,degrees Celsius,*degree*C*, +temperature_min_09,temperature_min_09,WorldClim_2.1_MIROC6_ssp585_10m,TRUE,WorldClim_2.1_MIROC6_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Sep,min T Sep,september,degrees Celsius,*degree*C*, +temperature_min_10,temperature_min_10,WorldClim_2.1_MIROC6_ssp585_10m,TRUE,WorldClim_2.1_MIROC6_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Oct,min T Oct,october,degrees Celsius,*degree*C*, +temperature_min_11,temperature_min_11,WorldClim_2.1_MIROC6_ssp585_10m,TRUE,WorldClim_2.1_MIROC6_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Nov,min T Nov,november,degrees Celsius,*degree*C*, +temperature_min_12,temperature_min_12,WorldClim_2.1_MIROC6_ssp585_10m,TRUE,WorldClim_2.1_MIROC6_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Dec,min T Dec,december,degrees Celsius,*degree*C*, +temperature_max_01,temperature_max_01,WorldClim_2.1_MIROC6_ssp585_10m,TRUE,WorldClim_2.1_MIROC6_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jan,max T Jan,january,degrees Celsius,*degree*C*, +temperature_max_02,temperature_max_02,WorldClim_2.1_MIROC6_ssp585_10m,TRUE,WorldClim_2.1_MIROC6_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Feb,max T Feb,february,degrees Celsius,*degree*C*, +temperature_max_03,temperature_max_03,WorldClim_2.1_MIROC6_ssp585_10m,TRUE,WorldClim_2.1_MIROC6_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Mar,max T Mar,march,degrees Celsius,*degree*C*, +temperature_max_04,temperature_max_04,WorldClim_2.1_MIROC6_ssp585_10m,TRUE,WorldClim_2.1_MIROC6_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Apr,max T Apr,april,degrees Celsius,*degree*C*, +temperature_max_05,temperature_max_05,WorldClim_2.1_MIROC6_ssp585_10m,TRUE,WorldClim_2.1_MIROC6_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature May,max T May,may,degrees Celsius,*degree*C*, +temperature_max_06,temperature_max_06,WorldClim_2.1_MIROC6_ssp585_10m,TRUE,WorldClim_2.1_MIROC6_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jun,max T Jun,june,degrees Celsius,*degree*C*, +temperature_max_07,temperature_max_07,WorldClim_2.1_MIROC6_ssp585_10m,TRUE,WorldClim_2.1_MIROC6_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jul,max T Jul,july,degrees Celsius,*degree*C*, +temperature_max_08,temperature_max_08,WorldClim_2.1_MIROC6_ssp585_10m,TRUE,WorldClim_2.1_MIROC6_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Aug,max T Aug,august,degrees Celsius,*degree*C*, +temperature_max_09,temperature_max_09,WorldClim_2.1_MIROC6_ssp585_10m,TRUE,WorldClim_2.1_MIROC6_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Sep,max T Sep,september,degrees Celsius,*degree*C*, +temperature_max_10,temperature_max_10,WorldClim_2.1_MIROC6_ssp585_10m,TRUE,WorldClim_2.1_MIROC6_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Oct,max T Oct,october,degrees Celsius,*degree*C*, +temperature_max_11,temperature_max_11,WorldClim_2.1_MIROC6_ssp585_10m,TRUE,WorldClim_2.1_MIROC6_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Nov,max T Nov,november,degrees Celsius,*degree*C*, +temperature_max_12,temperature_max_12,WorldClim_2.1_MIROC6_ssp585_10m,TRUE,WorldClim_2.1_MIROC6_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Dec,max T Dec,december,degrees Celsius,*degree*C*, +bio01,bio01,WorldClim_2.1_MIROC6_ssp585_5m,FALSE,WorldClim_2.1_MIROC6_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual mean temperature,ann. mean T,year,degrees Celsius,*degree*C*, +bio02,bio02,WorldClim_2.1_MIROC6_ssp585_5m,FALSE,WorldClim_2.1_MIROC6_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean diurnal range,diurn. range,year,degrees Celsius,*degree*C*, +bio03,bio03,WorldClim_2.1_MIROC6_ssp585_5m,FALSE,WorldClim_2.1_MIROC6_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,isothermality,isothermality,year,,, +bio04,bio04,WorldClim_2.1_MIROC6_ssp585_5m,FALSE,WorldClim_2.1_MIROC6_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature seasonality,T season.,year,degrees Celsius,*degree*C*, +bio05,bio05,WorldClim_2.1_MIROC6_ssp585_5m,FALSE,WorldClim_2.1_MIROC6_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature of warmest month,max. T of warmest mo.,year,degrees Celsius,*degree*C*, +bio06,bio06,WorldClim_2.1_MIROC6_ssp585_5m,FALSE,WorldClim_2.1_MIROC6_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature of coldest month,min. T of coldest mo.,year,degrees Celsius,*degree*C*, +bio07,bio07,WorldClim_2.1_MIROC6_ssp585_5m,FALSE,WorldClim_2.1_MIROC6_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature annual range (bio05-bio06),T ann. Range,year,degrees Celsius,*degree*C*, +bio08,bio08,WorldClim_2.1_MIROC6_ssp585_5m,FALSE,WorldClim_2.1_MIROC6_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of wettest quarter,mean T of wettest qtr,year,degrees Celsius,*degree*C*, +bio09,bio09,WorldClim_2.1_MIROC6_ssp585_5m,FALSE,WorldClim_2.1_MIROC6_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of driest quarter,mean T of driest qtr,year,degrees Celsius,*degree*C*, +bio10,bio10,WorldClim_2.1_MIROC6_ssp585_5m,FALSE,WorldClim_2.1_MIROC6_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of warmest quarter,mean T of warmest qtr,year,degrees Celsius,*degree*C*, +bio11,bio11,WorldClim_2.1_MIROC6_ssp585_5m,FALSE,WorldClim_2.1_MIROC6_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of coldest quarter,mean T of coldest qtr,year,degrees Celsius,*degree*C*, +bio12,bio12,WorldClim_2.1_MIROC6_ssp585_5m,FALSE,WorldClim_2.1_MIROC6_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual precipitation,ann. P,year,mm per year,*mm~yr^-1*, +bio13,bio13,WorldClim_2.1_MIROC6_ssp585_5m,FALSE,WorldClim_2.1_MIROC6_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest month,P of wettest mo.,year,mm per month,*mm~mo^-1*, +bio14,bio14,WorldClim_2.1_MIROC6_ssp585_5m,FALSE,WorldClim_2.1_MIROC6_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest month,P of driest mo.,year,mm per month,*mm~mo^-1*, +bio15,bio15,WorldClim_2.1_MIROC6_ssp585_5m,FALSE,WorldClim_2.1_MIROC6_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation seasonality (coeff var),P season.,year,,, +bio16,bio16,WorldClim_2.1_MIROC6_ssp585_5m,FALSE,WorldClim_2.1_MIROC6_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest quarter,P of wettest qtr,year,mm per quarter,*mm~qtr^-1*, +bio17,bio17,WorldClim_2.1_MIROC6_ssp585_5m,FALSE,WorldClim_2.1_MIROC6_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest quarter,P of driest qtr,year,mm per quarter,*mm~qtr^-1*, +bio18,bio18,WorldClim_2.1_MIROC6_ssp585_5m,FALSE,WorldClim_2.1_MIROC6_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of warmest quarter,P of warmest qtr,year,mm per quarter,*mm~qtr^-1*, +bio19,bio19,WorldClim_2.1_MIROC6_ssp585_5m,FALSE,WorldClim_2.1_MIROC6_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of coldest quarter,P of coldest qtr,year,mm per quarter,*mm~qtr^-1*, +precipitation_01,precipitation_01,WorldClim_2.1_MIROC6_ssp585_5m,TRUE,WorldClim_2.1_MIROC6_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jan,P Jan,january,mm per month,*mm~mo^-1*, +precipitation_02,precipitation_02,WorldClim_2.1_MIROC6_ssp585_5m,TRUE,WorldClim_2.1_MIROC6_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Feb,P Feb,february,mm per month,*mm~mo^-1*, +precipitation_03,precipitation_03,WorldClim_2.1_MIROC6_ssp585_5m,TRUE,WorldClim_2.1_MIROC6_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Mar,P Mar,march,mm per month,*mm~mo^-1*, +precipitation_04,precipitation_04,WorldClim_2.1_MIROC6_ssp585_5m,TRUE,WorldClim_2.1_MIROC6_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Apr,P Apr,april,mm per month,*mm~mo^-1*, +precipitation_05,precipitation_05,WorldClim_2.1_MIROC6_ssp585_5m,TRUE,WorldClim_2.1_MIROC6_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation May,P May,may,mm per month,*mm~mo^-1*, +precipitation_06,precipitation_06,WorldClim_2.1_MIROC6_ssp585_5m,TRUE,WorldClim_2.1_MIROC6_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jun,P Jun,june,mm per month,*mm~mo^-1*, +precipitation_07,precipitation_07,WorldClim_2.1_MIROC6_ssp585_5m,TRUE,WorldClim_2.1_MIROC6_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jul,P Jul,july,mm per month,*mm~mo^-1*, +precipitation_08,precipitation_08,WorldClim_2.1_MIROC6_ssp585_5m,TRUE,WorldClim_2.1_MIROC6_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Aug,P Aug,august,mm per month,*mm~mo^-1*, +precipitation_09,precipitation_09,WorldClim_2.1_MIROC6_ssp585_5m,TRUE,WorldClim_2.1_MIROC6_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Sep,P Sep,september,mm per month,*mm~mo^-1*, +precipitation_10,precipitation_10,WorldClim_2.1_MIROC6_ssp585_5m,TRUE,WorldClim_2.1_MIROC6_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Oct,P Oct,october,mm per month,*mm~mo^-1*, +precipitation_11,precipitation_11,WorldClim_2.1_MIROC6_ssp585_5m,TRUE,WorldClim_2.1_MIROC6_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Nov,P Nov,november,mm per month,*mm~mo^-1*, +precipitation_12,precipitation_12,WorldClim_2.1_MIROC6_ssp585_5m,TRUE,WorldClim_2.1_MIROC6_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Dec,P Dec,december,mm per month,*mm~mo^-1*, +temperature_min_01,temperature_min_01,WorldClim_2.1_MIROC6_ssp585_5m,TRUE,WorldClim_2.1_MIROC6_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jan,min T Jan,january,degrees Celsius,*degree*C*, +temperature_min_02,temperature_min_02,WorldClim_2.1_MIROC6_ssp585_5m,TRUE,WorldClim_2.1_MIROC6_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Feb,min T Feb,february,degrees Celsius,*degree*C*, +temperature_min_03,temperature_min_03,WorldClim_2.1_MIROC6_ssp585_5m,TRUE,WorldClim_2.1_MIROC6_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Mar,min T Mar,march,degrees Celsius,*degree*C*, +temperature_min_04,temperature_min_04,WorldClim_2.1_MIROC6_ssp585_5m,TRUE,WorldClim_2.1_MIROC6_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Apr,min T Apr,april,degrees Celsius,*degree*C*, +temperature_min_05,temperature_min_05,WorldClim_2.1_MIROC6_ssp585_5m,TRUE,WorldClim_2.1_MIROC6_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature May,min T May,may,degrees Celsius,*degree*C*, +temperature_min_06,temperature_min_06,WorldClim_2.1_MIROC6_ssp585_5m,TRUE,WorldClim_2.1_MIROC6_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jun,min T Jun,june,degrees Celsius,*degree*C*, +temperature_min_07,temperature_min_07,WorldClim_2.1_MIROC6_ssp585_5m,TRUE,WorldClim_2.1_MIROC6_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jul,min T Jul,july,degrees Celsius,*degree*C*, +temperature_min_08,temperature_min_08,WorldClim_2.1_MIROC6_ssp585_5m,TRUE,WorldClim_2.1_MIROC6_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Aug,min T Aug,august,degrees Celsius,*degree*C*, +temperature_min_09,temperature_min_09,WorldClim_2.1_MIROC6_ssp585_5m,TRUE,WorldClim_2.1_MIROC6_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Sep,min T Sep,september,degrees Celsius,*degree*C*, +temperature_min_10,temperature_min_10,WorldClim_2.1_MIROC6_ssp585_5m,TRUE,WorldClim_2.1_MIROC6_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Oct,min T Oct,october,degrees Celsius,*degree*C*, +temperature_min_11,temperature_min_11,WorldClim_2.1_MIROC6_ssp585_5m,TRUE,WorldClim_2.1_MIROC6_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Nov,min T Nov,november,degrees Celsius,*degree*C*, +temperature_min_12,temperature_min_12,WorldClim_2.1_MIROC6_ssp585_5m,TRUE,WorldClim_2.1_MIROC6_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Dec,min T Dec,december,degrees Celsius,*degree*C*, +temperature_max_01,temperature_max_01,WorldClim_2.1_MIROC6_ssp585_5m,TRUE,WorldClim_2.1_MIROC6_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jan,max T Jan,january,degrees Celsius,*degree*C*, +temperature_max_02,temperature_max_02,WorldClim_2.1_MIROC6_ssp585_5m,TRUE,WorldClim_2.1_MIROC6_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Feb,max T Feb,february,degrees Celsius,*degree*C*, +temperature_max_03,temperature_max_03,WorldClim_2.1_MIROC6_ssp585_5m,TRUE,WorldClim_2.1_MIROC6_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Mar,max T Mar,march,degrees Celsius,*degree*C*, +temperature_max_04,temperature_max_04,WorldClim_2.1_MIROC6_ssp585_5m,TRUE,WorldClim_2.1_MIROC6_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Apr,max T Apr,april,degrees Celsius,*degree*C*, +temperature_max_05,temperature_max_05,WorldClim_2.1_MIROC6_ssp585_5m,TRUE,WorldClim_2.1_MIROC6_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature May,max T May,may,degrees Celsius,*degree*C*, +temperature_max_06,temperature_max_06,WorldClim_2.1_MIROC6_ssp585_5m,TRUE,WorldClim_2.1_MIROC6_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jun,max T Jun,june,degrees Celsius,*degree*C*, +temperature_max_07,temperature_max_07,WorldClim_2.1_MIROC6_ssp585_5m,TRUE,WorldClim_2.1_MIROC6_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jul,max T Jul,july,degrees Celsius,*degree*C*, +temperature_max_08,temperature_max_08,WorldClim_2.1_MIROC6_ssp585_5m,TRUE,WorldClim_2.1_MIROC6_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Aug,max T Aug,august,degrees Celsius,*degree*C*, +temperature_max_09,temperature_max_09,WorldClim_2.1_MIROC6_ssp585_5m,TRUE,WorldClim_2.1_MIROC6_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Sep,max T Sep,september,degrees Celsius,*degree*C*, +temperature_max_10,temperature_max_10,WorldClim_2.1_MIROC6_ssp585_5m,TRUE,WorldClim_2.1_MIROC6_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Oct,max T Oct,october,degrees Celsius,*degree*C*, +temperature_max_11,temperature_max_11,WorldClim_2.1_MIROC6_ssp585_5m,TRUE,WorldClim_2.1_MIROC6_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Nov,max T Nov,november,degrees Celsius,*degree*C*, +temperature_max_12,temperature_max_12,WorldClim_2.1_MIROC6_ssp585_5m,TRUE,WorldClim_2.1_MIROC6_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Dec,max T Dec,december,degrees Celsius,*degree*C*, +bio01,bio01,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual mean temperature,ann. mean T,year,degrees Celsius,*degree*C*, +bio02,bio02,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean diurnal range,diurn. range,year,degrees Celsius,*degree*C*, +bio03,bio03,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,isothermality,isothermality,year,,, +bio04,bio04,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature seasonality,T season.,year,degrees Celsius,*degree*C*, +bio05,bio05,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature of warmest month,max. T of warmest mo.,year,degrees Celsius,*degree*C*, +bio06,bio06,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature of coldest month,min. T of coldest mo.,year,degrees Celsius,*degree*C*, +bio07,bio07,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature annual range (bio05-bio06),T ann. Range,year,degrees Celsius,*degree*C*, +bio08,bio08,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of wettest quarter,mean T of wettest qtr,year,degrees Celsius,*degree*C*, +bio09,bio09,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of driest quarter,mean T of driest qtr,year,degrees Celsius,*degree*C*, +bio10,bio10,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of warmest quarter,mean T of warmest qtr,year,degrees Celsius,*degree*C*, +bio11,bio11,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of coldest quarter,mean T of coldest qtr,year,degrees Celsius,*degree*C*, +bio12,bio12,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual precipitation,ann. P,year,mm per year,*mm~yr^-1*, +bio13,bio13,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest month,P of wettest mo.,year,mm per month,*mm~mo^-1*, +bio14,bio14,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest month,P of driest mo.,year,mm per month,*mm~mo^-1*, +bio15,bio15,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation seasonality (coeff var),P season.,year,,, +bio16,bio16,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest quarter,P of wettest qtr,year,mm per quarter,*mm~qtr^-1*, +bio17,bio17,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest quarter,P of driest qtr,year,mm per quarter,*mm~qtr^-1*, +bio18,bio18,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of warmest quarter,P of warmest qtr,year,mm per quarter,*mm~qtr^-1*, +bio19,bio19,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of coldest quarter,P of coldest qtr,year,mm per quarter,*mm~qtr^-1*, +precipitation_01,precipitation_01,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jan,P Jan,january,mm per month,*mm~mo^-1*, +precipitation_02,precipitation_02,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Feb,P Feb,february,mm per month,*mm~mo^-1*, +precipitation_03,precipitation_03,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Mar,P Mar,march,mm per month,*mm~mo^-1*, +precipitation_04,precipitation_04,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Apr,P Apr,april,mm per month,*mm~mo^-1*, +precipitation_05,precipitation_05,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation May,P May,may,mm per month,*mm~mo^-1*, +precipitation_06,precipitation_06,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jun,P Jun,june,mm per month,*mm~mo^-1*, +precipitation_07,precipitation_07,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jul,P Jul,july,mm per month,*mm~mo^-1*, +precipitation_08,precipitation_08,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Aug,P Aug,august,mm per month,*mm~mo^-1*, +precipitation_09,precipitation_09,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Sep,P Sep,september,mm per month,*mm~mo^-1*, +precipitation_10,precipitation_10,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Oct,P Oct,october,mm per month,*mm~mo^-1*, +precipitation_11,precipitation_11,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Nov,P Nov,november,mm per month,*mm~mo^-1*, +precipitation_12,precipitation_12,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Dec,P Dec,december,mm per month,*mm~mo^-1*, +temperature_min_01,temperature_min_01,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jan,min T Jan,january,degrees Celsius,*degree*C*, +temperature_min_02,temperature_min_02,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Feb,min T Feb,february,degrees Celsius,*degree*C*, +temperature_min_03,temperature_min_03,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Mar,min T Mar,march,degrees Celsius,*degree*C*, +temperature_min_04,temperature_min_04,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Apr,min T Apr,april,degrees Celsius,*degree*C*, +temperature_min_05,temperature_min_05,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature May,min T May,may,degrees Celsius,*degree*C*, +temperature_min_06,temperature_min_06,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jun,min T Jun,june,degrees Celsius,*degree*C*, +temperature_min_07,temperature_min_07,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jul,min T Jul,july,degrees Celsius,*degree*C*, +temperature_min_08,temperature_min_08,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Aug,min T Aug,august,degrees Celsius,*degree*C*, +temperature_min_09,temperature_min_09,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Sep,min T Sep,september,degrees Celsius,*degree*C*, +temperature_min_10,temperature_min_10,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Oct,min T Oct,october,degrees Celsius,*degree*C*, +temperature_min_11,temperature_min_11,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Nov,min T Nov,november,degrees Celsius,*degree*C*, +temperature_min_12,temperature_min_12,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Dec,min T Dec,december,degrees Celsius,*degree*C*, +temperature_max_01,temperature_max_01,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jan,max T Jan,january,degrees Celsius,*degree*C*, +temperature_max_02,temperature_max_02,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Feb,max T Feb,february,degrees Celsius,*degree*C*, +temperature_max_03,temperature_max_03,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Mar,max T Mar,march,degrees Celsius,*degree*C*, +temperature_max_04,temperature_max_04,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Apr,max T Apr,april,degrees Celsius,*degree*C*, +temperature_max_05,temperature_max_05,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature May,max T May,may,degrees Celsius,*degree*C*, +temperature_max_06,temperature_max_06,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jun,max T Jun,june,degrees Celsius,*degree*C*, +temperature_max_07,temperature_max_07,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jul,max T Jul,july,degrees Celsius,*degree*C*, +temperature_max_08,temperature_max_08,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Aug,max T Aug,august,degrees Celsius,*degree*C*, +temperature_max_09,temperature_max_09,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Sep,max T Sep,september,degrees Celsius,*degree*C*, +temperature_max_10,temperature_max_10,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Oct,max T Oct,october,degrees Celsius,*degree*C*, +temperature_max_11,temperature_max_11,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Nov,max T Nov,november,degrees Celsius,*degree*C*, +temperature_max_12,temperature_max_12,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Dec,max T Dec,december,degrees Celsius,*degree*C*, +bio01,bio01,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual mean temperature,ann. mean T,year,degrees Celsius,*degree*C*, +bio02,bio02,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean diurnal range,diurn. range,year,degrees Celsius,*degree*C*, +bio03,bio03,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,isothermality,isothermality,year,,, +bio04,bio04,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature seasonality,T season.,year,degrees Celsius,*degree*C*, +bio05,bio05,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature of warmest month,max. T of warmest mo.,year,degrees Celsius,*degree*C*, +bio06,bio06,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature of coldest month,min. T of coldest mo.,year,degrees Celsius,*degree*C*, +bio07,bio07,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature annual range (bio05-bio06),T ann. Range,year,degrees Celsius,*degree*C*, +bio08,bio08,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of wettest quarter,mean T of wettest qtr,year,degrees Celsius,*degree*C*, +bio09,bio09,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of driest quarter,mean T of driest qtr,year,degrees Celsius,*degree*C*, +bio10,bio10,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of warmest quarter,mean T of warmest qtr,year,degrees Celsius,*degree*C*, +bio11,bio11,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of coldest quarter,mean T of coldest qtr,year,degrees Celsius,*degree*C*, +bio12,bio12,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual precipitation,ann. P,year,mm per year,*mm~yr^-1*, +bio13,bio13,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest month,P of wettest mo.,year,mm per month,*mm~mo^-1*, +bio14,bio14,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest month,P of driest mo.,year,mm per month,*mm~mo^-1*, +bio15,bio15,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation seasonality (coeff var),P season.,year,,, +bio16,bio16,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest quarter,P of wettest qtr,year,mm per quarter,*mm~qtr^-1*, +bio17,bio17,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest quarter,P of driest qtr,year,mm per quarter,*mm~qtr^-1*, +bio18,bio18,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of warmest quarter,P of warmest qtr,year,mm per quarter,*mm~qtr^-1*, +bio19,bio19,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of coldest quarter,P of coldest qtr,year,mm per quarter,*mm~qtr^-1*, +precipitation_01,precipitation_01,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jan,P Jan,january,mm per month,*mm~mo^-1*, +precipitation_02,precipitation_02,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Feb,P Feb,february,mm per month,*mm~mo^-1*, +precipitation_03,precipitation_03,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Mar,P Mar,march,mm per month,*mm~mo^-1*, +precipitation_04,precipitation_04,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Apr,P Apr,april,mm per month,*mm~mo^-1*, +precipitation_05,precipitation_05,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation May,P May,may,mm per month,*mm~mo^-1*, +precipitation_06,precipitation_06,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jun,P Jun,june,mm per month,*mm~mo^-1*, +precipitation_07,precipitation_07,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jul,P Jul,july,mm per month,*mm~mo^-1*, +precipitation_08,precipitation_08,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Aug,P Aug,august,mm per month,*mm~mo^-1*, +precipitation_09,precipitation_09,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Sep,P Sep,september,mm per month,*mm~mo^-1*, +precipitation_10,precipitation_10,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Oct,P Oct,october,mm per month,*mm~mo^-1*, +precipitation_11,precipitation_11,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Nov,P Nov,november,mm per month,*mm~mo^-1*, +precipitation_12,precipitation_12,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Dec,P Dec,december,mm per month,*mm~mo^-1*, +temperature_min_01,temperature_min_01,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jan,min T Jan,january,degrees Celsius,*degree*C*, +temperature_min_02,temperature_min_02,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Feb,min T Feb,february,degrees Celsius,*degree*C*, +temperature_min_03,temperature_min_03,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Mar,min T Mar,march,degrees Celsius,*degree*C*, +temperature_min_04,temperature_min_04,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Apr,min T Apr,april,degrees Celsius,*degree*C*, +temperature_min_05,temperature_min_05,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature May,min T May,may,degrees Celsius,*degree*C*, +temperature_min_06,temperature_min_06,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jun,min T Jun,june,degrees Celsius,*degree*C*, +temperature_min_07,temperature_min_07,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jul,min T Jul,july,degrees Celsius,*degree*C*, +temperature_min_08,temperature_min_08,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Aug,min T Aug,august,degrees Celsius,*degree*C*, +temperature_min_09,temperature_min_09,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Sep,min T Sep,september,degrees Celsius,*degree*C*, +temperature_min_10,temperature_min_10,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Oct,min T Oct,october,degrees Celsius,*degree*C*, +temperature_min_11,temperature_min_11,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Nov,min T Nov,november,degrees Celsius,*degree*C*, +temperature_min_12,temperature_min_12,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Dec,min T Dec,december,degrees Celsius,*degree*C*, +temperature_max_01,temperature_max_01,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jan,max T Jan,january,degrees Celsius,*degree*C*, +temperature_max_02,temperature_max_02,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Feb,max T Feb,february,degrees Celsius,*degree*C*, +temperature_max_03,temperature_max_03,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Mar,max T Mar,march,degrees Celsius,*degree*C*, +temperature_max_04,temperature_max_04,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Apr,max T Apr,april,degrees Celsius,*degree*C*, +temperature_max_05,temperature_max_05,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature May,max T May,may,degrees Celsius,*degree*C*, +temperature_max_06,temperature_max_06,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jun,max T Jun,june,degrees Celsius,*degree*C*, +temperature_max_07,temperature_max_07,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jul,max T Jul,july,degrees Celsius,*degree*C*, +temperature_max_08,temperature_max_08,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Aug,max T Aug,august,degrees Celsius,*degree*C*, +temperature_max_09,temperature_max_09,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Sep,max T Sep,september,degrees Celsius,*degree*C*, +temperature_max_10,temperature_max_10,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Oct,max T Oct,october,degrees Celsius,*degree*C*, +temperature_max_11,temperature_max_11,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Nov,max T Nov,november,degrees Celsius,*degree*C*, +temperature_max_12,temperature_max_12,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Dec,max T Dec,december,degrees Celsius,*degree*C*, +bio01,bio01,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual mean temperature,ann. mean T,year,degrees Celsius,*degree*C*, +bio02,bio02,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean diurnal range,diurn. range,year,degrees Celsius,*degree*C*, +bio03,bio03,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,isothermality,isothermality,year,,, +bio04,bio04,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature seasonality,T season.,year,degrees Celsius,*degree*C*, +bio05,bio05,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature of warmest month,max. T of warmest mo.,year,degrees Celsius,*degree*C*, +bio06,bio06,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature of coldest month,min. T of coldest mo.,year,degrees Celsius,*degree*C*, +bio07,bio07,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature annual range (bio05-bio06),T ann. Range,year,degrees Celsius,*degree*C*, +bio08,bio08,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of wettest quarter,mean T of wettest qtr,year,degrees Celsius,*degree*C*, +bio09,bio09,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of driest quarter,mean T of driest qtr,year,degrees Celsius,*degree*C*, +bio10,bio10,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of warmest quarter,mean T of warmest qtr,year,degrees Celsius,*degree*C*, +bio11,bio11,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of coldest quarter,mean T of coldest qtr,year,degrees Celsius,*degree*C*, +bio12,bio12,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual precipitation,ann. P,year,mm per year,*mm~yr^-1*, +bio13,bio13,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest month,P of wettest mo.,year,mm per month,*mm~mo^-1*, +bio14,bio14,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest month,P of driest mo.,year,mm per month,*mm~mo^-1*, +bio15,bio15,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation seasonality (coeff var),P season.,year,,, +bio16,bio16,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest quarter,P of wettest qtr,year,mm per quarter,*mm~qtr^-1*, +bio17,bio17,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest quarter,P of driest qtr,year,mm per quarter,*mm~qtr^-1*, +bio18,bio18,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of warmest quarter,P of warmest qtr,year,mm per quarter,*mm~qtr^-1*, +bio19,bio19,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of coldest quarter,P of coldest qtr,year,mm per quarter,*mm~qtr^-1*, +precipitation_01,precipitation_01,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jan,P Jan,january,mm per month,*mm~mo^-1*, +precipitation_02,precipitation_02,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Feb,P Feb,february,mm per month,*mm~mo^-1*, +precipitation_03,precipitation_03,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Mar,P Mar,march,mm per month,*mm~mo^-1*, +precipitation_04,precipitation_04,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Apr,P Apr,april,mm per month,*mm~mo^-1*, +precipitation_05,precipitation_05,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation May,P May,may,mm per month,*mm~mo^-1*, +precipitation_06,precipitation_06,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jun,P Jun,june,mm per month,*mm~mo^-1*, +precipitation_07,precipitation_07,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jul,P Jul,july,mm per month,*mm~mo^-1*, +precipitation_08,precipitation_08,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Aug,P Aug,august,mm per month,*mm~mo^-1*, +precipitation_09,precipitation_09,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Sep,P Sep,september,mm per month,*mm~mo^-1*, +precipitation_10,precipitation_10,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Oct,P Oct,october,mm per month,*mm~mo^-1*, +precipitation_11,precipitation_11,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Nov,P Nov,november,mm per month,*mm~mo^-1*, +precipitation_12,precipitation_12,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Dec,P Dec,december,mm per month,*mm~mo^-1*, +temperature_min_01,temperature_min_01,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jan,min T Jan,january,degrees Celsius,*degree*C*, +temperature_min_02,temperature_min_02,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Feb,min T Feb,february,degrees Celsius,*degree*C*, +temperature_min_03,temperature_min_03,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Mar,min T Mar,march,degrees Celsius,*degree*C*, +temperature_min_04,temperature_min_04,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Apr,min T Apr,april,degrees Celsius,*degree*C*, +temperature_min_05,temperature_min_05,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature May,min T May,may,degrees Celsius,*degree*C*, +temperature_min_06,temperature_min_06,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jun,min T Jun,june,degrees Celsius,*degree*C*, +temperature_min_07,temperature_min_07,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jul,min T Jul,july,degrees Celsius,*degree*C*, +temperature_min_08,temperature_min_08,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Aug,min T Aug,august,degrees Celsius,*degree*C*, +temperature_min_09,temperature_min_09,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Sep,min T Sep,september,degrees Celsius,*degree*C*, +temperature_min_10,temperature_min_10,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Oct,min T Oct,october,degrees Celsius,*degree*C*, +temperature_min_11,temperature_min_11,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Nov,min T Nov,november,degrees Celsius,*degree*C*, +temperature_min_12,temperature_min_12,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Dec,min T Dec,december,degrees Celsius,*degree*C*, +temperature_max_01,temperature_max_01,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jan,max T Jan,january,degrees Celsius,*degree*C*, +temperature_max_02,temperature_max_02,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Feb,max T Feb,february,degrees Celsius,*degree*C*, +temperature_max_03,temperature_max_03,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Mar,max T Mar,march,degrees Celsius,*degree*C*, +temperature_max_04,temperature_max_04,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Apr,max T Apr,april,degrees Celsius,*degree*C*, +temperature_max_05,temperature_max_05,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature May,max T May,may,degrees Celsius,*degree*C*, +temperature_max_06,temperature_max_06,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jun,max T Jun,june,degrees Celsius,*degree*C*, +temperature_max_07,temperature_max_07,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jul,max T Jul,july,degrees Celsius,*degree*C*, +temperature_max_08,temperature_max_08,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Aug,max T Aug,august,degrees Celsius,*degree*C*, +temperature_max_09,temperature_max_09,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Sep,max T Sep,september,degrees Celsius,*degree*C*, +temperature_max_10,temperature_max_10,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Oct,max T Oct,october,degrees Celsius,*degree*C*, +temperature_max_11,temperature_max_11,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Nov,max T Nov,november,degrees Celsius,*degree*C*, +temperature_max_12,temperature_max_12,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Dec,max T Dec,december,degrees Celsius,*degree*C*, +bio01,bio01,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual mean temperature,ann. mean T,year,degrees Celsius,*degree*C*, +bio02,bio02,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean diurnal range,diurn. range,year,degrees Celsius,*degree*C*, +bio03,bio03,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,isothermality,isothermality,year,,, +bio04,bio04,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature seasonality,T season.,year,degrees Celsius,*degree*C*, +bio05,bio05,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature of warmest month,max. T of warmest mo.,year,degrees Celsius,*degree*C*, +bio06,bio06,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature of coldest month,min. T of coldest mo.,year,degrees Celsius,*degree*C*, +bio07,bio07,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature annual range (bio05-bio06),T ann. Range,year,degrees Celsius,*degree*C*, +bio08,bio08,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of wettest quarter,mean T of wettest qtr,year,degrees Celsius,*degree*C*, +bio09,bio09,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of driest quarter,mean T of driest qtr,year,degrees Celsius,*degree*C*, +bio10,bio10,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of warmest quarter,mean T of warmest qtr,year,degrees Celsius,*degree*C*, +bio11,bio11,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of coldest quarter,mean T of coldest qtr,year,degrees Celsius,*degree*C*, +bio12,bio12,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual precipitation,ann. P,year,mm per year,*mm~yr^-1*, +bio13,bio13,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest month,P of wettest mo.,year,mm per month,*mm~mo^-1*, +bio14,bio14,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest month,P of driest mo.,year,mm per month,*mm~mo^-1*, +bio15,bio15,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation seasonality (coeff var),P season.,year,,, +bio16,bio16,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest quarter,P of wettest qtr,year,mm per quarter,*mm~qtr^-1*, +bio17,bio17,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest quarter,P of driest qtr,year,mm per quarter,*mm~qtr^-1*, +bio18,bio18,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of warmest quarter,P of warmest qtr,year,mm per quarter,*mm~qtr^-1*, +bio19,bio19,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of coldest quarter,P of coldest qtr,year,mm per quarter,*mm~qtr^-1*, +precipitation_01,precipitation_01,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jan,P Jan,january,mm per month,*mm~mo^-1*, +precipitation_02,precipitation_02,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Feb,P Feb,february,mm per month,*mm~mo^-1*, +precipitation_03,precipitation_03,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Mar,P Mar,march,mm per month,*mm~mo^-1*, +precipitation_04,precipitation_04,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Apr,P Apr,april,mm per month,*mm~mo^-1*, +precipitation_05,precipitation_05,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation May,P May,may,mm per month,*mm~mo^-1*, +precipitation_06,precipitation_06,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jun,P Jun,june,mm per month,*mm~mo^-1*, +precipitation_07,precipitation_07,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jul,P Jul,july,mm per month,*mm~mo^-1*, +precipitation_08,precipitation_08,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Aug,P Aug,august,mm per month,*mm~mo^-1*, +precipitation_09,precipitation_09,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Sep,P Sep,september,mm per month,*mm~mo^-1*, +precipitation_10,precipitation_10,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Oct,P Oct,october,mm per month,*mm~mo^-1*, +precipitation_11,precipitation_11,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Nov,P Nov,november,mm per month,*mm~mo^-1*, +precipitation_12,precipitation_12,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Dec,P Dec,december,mm per month,*mm~mo^-1*, +temperature_min_01,temperature_min_01,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jan,min T Jan,january,degrees Celsius,*degree*C*, +temperature_min_02,temperature_min_02,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Feb,min T Feb,february,degrees Celsius,*degree*C*, +temperature_min_03,temperature_min_03,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Mar,min T Mar,march,degrees Celsius,*degree*C*, +temperature_min_04,temperature_min_04,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Apr,min T Apr,april,degrees Celsius,*degree*C*, +temperature_min_05,temperature_min_05,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature May,min T May,may,degrees Celsius,*degree*C*, +temperature_min_06,temperature_min_06,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jun,min T Jun,june,degrees Celsius,*degree*C*, +temperature_min_07,temperature_min_07,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jul,min T Jul,july,degrees Celsius,*degree*C*, +temperature_min_08,temperature_min_08,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Aug,min T Aug,august,degrees Celsius,*degree*C*, +temperature_min_09,temperature_min_09,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Sep,min T Sep,september,degrees Celsius,*degree*C*, +temperature_min_10,temperature_min_10,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Oct,min T Oct,october,degrees Celsius,*degree*C*, +temperature_min_11,temperature_min_11,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Nov,min T Nov,november,degrees Celsius,*degree*C*, +temperature_min_12,temperature_min_12,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Dec,min T Dec,december,degrees Celsius,*degree*C*, +temperature_max_01,temperature_max_01,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jan,max T Jan,january,degrees Celsius,*degree*C*, +temperature_max_02,temperature_max_02,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Feb,max T Feb,february,degrees Celsius,*degree*C*, +temperature_max_03,temperature_max_03,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Mar,max T Mar,march,degrees Celsius,*degree*C*, +temperature_max_04,temperature_max_04,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Apr,max T Apr,april,degrees Celsius,*degree*C*, +temperature_max_05,temperature_max_05,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature May,max T May,may,degrees Celsius,*degree*C*, +temperature_max_06,temperature_max_06,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jun,max T Jun,june,degrees Celsius,*degree*C*, +temperature_max_07,temperature_max_07,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jul,max T Jul,july,degrees Celsius,*degree*C*, +temperature_max_08,temperature_max_08,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Aug,max T Aug,august,degrees Celsius,*degree*C*, +temperature_max_09,temperature_max_09,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Sep,max T Sep,september,degrees Celsius,*degree*C*, +temperature_max_10,temperature_max_10,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Oct,max T Oct,october,degrees Celsius,*degree*C*, +temperature_max_11,temperature_max_11,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Nov,max T Nov,november,degrees Celsius,*degree*C*, +temperature_max_12,temperature_max_12,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Dec,max T Dec,december,degrees Celsius,*degree*C*, +bio01,bio01,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual mean temperature,ann. mean T,year,degrees Celsius,*degree*C*, +bio02,bio02,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean diurnal range,diurn. range,year,degrees Celsius,*degree*C*, +bio03,bio03,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,isothermality,isothermality,year,,, +bio04,bio04,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature seasonality,T season.,year,degrees Celsius,*degree*C*, +bio05,bio05,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature of warmest month,max. T of warmest mo.,year,degrees Celsius,*degree*C*, +bio06,bio06,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature of coldest month,min. T of coldest mo.,year,degrees Celsius,*degree*C*, +bio07,bio07,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature annual range (bio05-bio06),T ann. Range,year,degrees Celsius,*degree*C*, +bio08,bio08,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of wettest quarter,mean T of wettest qtr,year,degrees Celsius,*degree*C*, +bio09,bio09,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of driest quarter,mean T of driest qtr,year,degrees Celsius,*degree*C*, +bio10,bio10,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of warmest quarter,mean T of warmest qtr,year,degrees Celsius,*degree*C*, +bio11,bio11,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of coldest quarter,mean T of coldest qtr,year,degrees Celsius,*degree*C*, +bio12,bio12,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual precipitation,ann. P,year,mm per year,*mm~yr^-1*, +bio13,bio13,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest month,P of wettest mo.,year,mm per month,*mm~mo^-1*, +bio14,bio14,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest month,P of driest mo.,year,mm per month,*mm~mo^-1*, +bio15,bio15,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation seasonality (coeff var),P season.,year,,, +bio16,bio16,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest quarter,P of wettest qtr,year,mm per quarter,*mm~qtr^-1*, +bio17,bio17,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest quarter,P of driest qtr,year,mm per quarter,*mm~qtr^-1*, +bio18,bio18,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of warmest quarter,P of warmest qtr,year,mm per quarter,*mm~qtr^-1*, +bio19,bio19,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of coldest quarter,P of coldest qtr,year,mm per quarter,*mm~qtr^-1*, +precipitation_01,precipitation_01,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jan,P Jan,january,mm per month,*mm~mo^-1*, +precipitation_02,precipitation_02,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Feb,P Feb,february,mm per month,*mm~mo^-1*, +precipitation_03,precipitation_03,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Mar,P Mar,march,mm per month,*mm~mo^-1*, +precipitation_04,precipitation_04,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Apr,P Apr,april,mm per month,*mm~mo^-1*, +precipitation_05,precipitation_05,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation May,P May,may,mm per month,*mm~mo^-1*, +precipitation_06,precipitation_06,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jun,P Jun,june,mm per month,*mm~mo^-1*, +precipitation_07,precipitation_07,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jul,P Jul,july,mm per month,*mm~mo^-1*, +precipitation_08,precipitation_08,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Aug,P Aug,august,mm per month,*mm~mo^-1*, +precipitation_09,precipitation_09,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Sep,P Sep,september,mm per month,*mm~mo^-1*, +precipitation_10,precipitation_10,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Oct,P Oct,october,mm per month,*mm~mo^-1*, +precipitation_11,precipitation_11,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Nov,P Nov,november,mm per month,*mm~mo^-1*, +precipitation_12,precipitation_12,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Dec,P Dec,december,mm per month,*mm~mo^-1*, +temperature_min_01,temperature_min_01,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jan,min T Jan,january,degrees Celsius,*degree*C*, +temperature_min_02,temperature_min_02,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Feb,min T Feb,february,degrees Celsius,*degree*C*, +temperature_min_03,temperature_min_03,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Mar,min T Mar,march,degrees Celsius,*degree*C*, +temperature_min_04,temperature_min_04,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Apr,min T Apr,april,degrees Celsius,*degree*C*, +temperature_min_05,temperature_min_05,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature May,min T May,may,degrees Celsius,*degree*C*, +temperature_min_06,temperature_min_06,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jun,min T Jun,june,degrees Celsius,*degree*C*, +temperature_min_07,temperature_min_07,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jul,min T Jul,july,degrees Celsius,*degree*C*, +temperature_min_08,temperature_min_08,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Aug,min T Aug,august,degrees Celsius,*degree*C*, +temperature_min_09,temperature_min_09,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Sep,min T Sep,september,degrees Celsius,*degree*C*, +temperature_min_10,temperature_min_10,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Oct,min T Oct,october,degrees Celsius,*degree*C*, +temperature_min_11,temperature_min_11,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Nov,min T Nov,november,degrees Celsius,*degree*C*, +temperature_min_12,temperature_min_12,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Dec,min T Dec,december,degrees Celsius,*degree*C*, +temperature_max_01,temperature_max_01,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jan,max T Jan,january,degrees Celsius,*degree*C*, +temperature_max_02,temperature_max_02,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Feb,max T Feb,february,degrees Celsius,*degree*C*, +temperature_max_03,temperature_max_03,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Mar,max T Mar,march,degrees Celsius,*degree*C*, +temperature_max_04,temperature_max_04,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Apr,max T Apr,april,degrees Celsius,*degree*C*, +temperature_max_05,temperature_max_05,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature May,max T May,may,degrees Celsius,*degree*C*, +temperature_max_06,temperature_max_06,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jun,max T Jun,june,degrees Celsius,*degree*C*, +temperature_max_07,temperature_max_07,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jul,max T Jul,july,degrees Celsius,*degree*C*, +temperature_max_08,temperature_max_08,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Aug,max T Aug,august,degrees Celsius,*degree*C*, +temperature_max_09,temperature_max_09,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Sep,max T Sep,september,degrees Celsius,*degree*C*, +temperature_max_10,temperature_max_10,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Oct,max T Oct,october,degrees Celsius,*degree*C*, +temperature_max_11,temperature_max_11,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Nov,max T Nov,november,degrees Celsius,*degree*C*, +temperature_max_12,temperature_max_12,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Dec,max T Dec,december,degrees Celsius,*degree*C*, +bio01,bio01,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual mean temperature,ann. mean T,year,degrees Celsius,*degree*C*, +bio02,bio02,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean diurnal range,diurn. range,year,degrees Celsius,*degree*C*, +bio03,bio03,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,isothermality,isothermality,year,,, +bio04,bio04,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature seasonality,T season.,year,degrees Celsius,*degree*C*, +bio05,bio05,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature of warmest month,max. T of warmest mo.,year,degrees Celsius,*degree*C*, +bio06,bio06,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature of coldest month,min. T of coldest mo.,year,degrees Celsius,*degree*C*, +bio07,bio07,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature annual range (bio05-bio06),T ann. Range,year,degrees Celsius,*degree*C*, +bio08,bio08,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of wettest quarter,mean T of wettest qtr,year,degrees Celsius,*degree*C*, +bio09,bio09,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of driest quarter,mean T of driest qtr,year,degrees Celsius,*degree*C*, +bio10,bio10,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of warmest quarter,mean T of warmest qtr,year,degrees Celsius,*degree*C*, +bio11,bio11,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of coldest quarter,mean T of coldest qtr,year,degrees Celsius,*degree*C*, +bio12,bio12,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual precipitation,ann. P,year,mm per year,*mm~yr^-1*, +bio13,bio13,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest month,P of wettest mo.,year,mm per month,*mm~mo^-1*, +bio14,bio14,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest month,P of driest mo.,year,mm per month,*mm~mo^-1*, +bio15,bio15,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation seasonality (coeff var),P season.,year,,, +bio16,bio16,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest quarter,P of wettest qtr,year,mm per quarter,*mm~qtr^-1*, +bio17,bio17,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest quarter,P of driest qtr,year,mm per quarter,*mm~qtr^-1*, +bio18,bio18,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of warmest quarter,P of warmest qtr,year,mm per quarter,*mm~qtr^-1*, +bio19,bio19,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of coldest quarter,P of coldest qtr,year,mm per quarter,*mm~qtr^-1*, +precipitation_01,precipitation_01,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jan,P Jan,january,mm per month,*mm~mo^-1*, +precipitation_02,precipitation_02,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Feb,P Feb,february,mm per month,*mm~mo^-1*, +precipitation_03,precipitation_03,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Mar,P Mar,march,mm per month,*mm~mo^-1*, +precipitation_04,precipitation_04,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Apr,P Apr,april,mm per month,*mm~mo^-1*, +precipitation_05,precipitation_05,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation May,P May,may,mm per month,*mm~mo^-1*, +precipitation_06,precipitation_06,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jun,P Jun,june,mm per month,*mm~mo^-1*, +precipitation_07,precipitation_07,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jul,P Jul,july,mm per month,*mm~mo^-1*, +precipitation_08,precipitation_08,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Aug,P Aug,august,mm per month,*mm~mo^-1*, +precipitation_09,precipitation_09,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Sep,P Sep,september,mm per month,*mm~mo^-1*, +precipitation_10,precipitation_10,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Oct,P Oct,october,mm per month,*mm~mo^-1*, +precipitation_11,precipitation_11,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Nov,P Nov,november,mm per month,*mm~mo^-1*, +precipitation_12,precipitation_12,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Dec,P Dec,december,mm per month,*mm~mo^-1*, +temperature_min_01,temperature_min_01,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jan,min T Jan,january,degrees Celsius,*degree*C*, +temperature_min_02,temperature_min_02,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Feb,min T Feb,february,degrees Celsius,*degree*C*, +temperature_min_03,temperature_min_03,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Mar,min T Mar,march,degrees Celsius,*degree*C*, +temperature_min_04,temperature_min_04,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Apr,min T Apr,april,degrees Celsius,*degree*C*, +temperature_min_05,temperature_min_05,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature May,min T May,may,degrees Celsius,*degree*C*, +temperature_min_06,temperature_min_06,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jun,min T Jun,june,degrees Celsius,*degree*C*, +temperature_min_07,temperature_min_07,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jul,min T Jul,july,degrees Celsius,*degree*C*, +temperature_min_08,temperature_min_08,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Aug,min T Aug,august,degrees Celsius,*degree*C*, +temperature_min_09,temperature_min_09,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Sep,min T Sep,september,degrees Celsius,*degree*C*, +temperature_min_10,temperature_min_10,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Oct,min T Oct,october,degrees Celsius,*degree*C*, +temperature_min_11,temperature_min_11,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Nov,min T Nov,november,degrees Celsius,*degree*C*, +temperature_min_12,temperature_min_12,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Dec,min T Dec,december,degrees Celsius,*degree*C*, +temperature_max_01,temperature_max_01,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jan,max T Jan,january,degrees Celsius,*degree*C*, +temperature_max_02,temperature_max_02,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Feb,max T Feb,february,degrees Celsius,*degree*C*, +temperature_max_03,temperature_max_03,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Mar,max T Mar,march,degrees Celsius,*degree*C*, +temperature_max_04,temperature_max_04,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Apr,max T Apr,april,degrees Celsius,*degree*C*, +temperature_max_05,temperature_max_05,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature May,max T May,may,degrees Celsius,*degree*C*, +temperature_max_06,temperature_max_06,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jun,max T Jun,june,degrees Celsius,*degree*C*, +temperature_max_07,temperature_max_07,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jul,max T Jul,july,degrees Celsius,*degree*C*, +temperature_max_08,temperature_max_08,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Aug,max T Aug,august,degrees Celsius,*degree*C*, +temperature_max_09,temperature_max_09,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Sep,max T Sep,september,degrees Celsius,*degree*C*, +temperature_max_10,temperature_max_10,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Oct,max T Oct,october,degrees Celsius,*degree*C*, +temperature_max_11,temperature_max_11,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Nov,max T Nov,november,degrees Celsius,*degree*C*, +temperature_max_12,temperature_max_12,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Dec,max T Dec,december,degrees Celsius,*degree*C*, +bio01,bio01,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual mean temperature,ann. mean T,year,degrees Celsius,*degree*C*, +bio02,bio02,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean diurnal range,diurn. range,year,degrees Celsius,*degree*C*, +bio03,bio03,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,isothermality,isothermality,year,,, +bio04,bio04,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature seasonality,T season.,year,degrees Celsius,*degree*C*, +bio05,bio05,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature of warmest month,max. T of warmest mo.,year,degrees Celsius,*degree*C*, +bio06,bio06,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature of coldest month,min. T of coldest mo.,year,degrees Celsius,*degree*C*, +bio07,bio07,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature annual range (bio05-bio06),T ann. Range,year,degrees Celsius,*degree*C*, +bio08,bio08,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of wettest quarter,mean T of wettest qtr,year,degrees Celsius,*degree*C*, +bio09,bio09,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of driest quarter,mean T of driest qtr,year,degrees Celsius,*degree*C*, +bio10,bio10,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of warmest quarter,mean T of warmest qtr,year,degrees Celsius,*degree*C*, +bio11,bio11,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of coldest quarter,mean T of coldest qtr,year,degrees Celsius,*degree*C*, +bio12,bio12,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual precipitation,ann. P,year,mm per year,*mm~yr^-1*, +bio13,bio13,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest month,P of wettest mo.,year,mm per month,*mm~mo^-1*, +bio14,bio14,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest month,P of driest mo.,year,mm per month,*mm~mo^-1*, +bio15,bio15,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation seasonality (coeff var),P season.,year,,, +bio16,bio16,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest quarter,P of wettest qtr,year,mm per quarter,*mm~qtr^-1*, +bio17,bio17,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest quarter,P of driest qtr,year,mm per quarter,*mm~qtr^-1*, +bio18,bio18,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of warmest quarter,P of warmest qtr,year,mm per quarter,*mm~qtr^-1*, +bio19,bio19,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of coldest quarter,P of coldest qtr,year,mm per quarter,*mm~qtr^-1*, +precipitation_01,precipitation_01,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jan,P Jan,january,mm per month,*mm~mo^-1*, +precipitation_02,precipitation_02,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Feb,P Feb,february,mm per month,*mm~mo^-1*, +precipitation_03,precipitation_03,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Mar,P Mar,march,mm per month,*mm~mo^-1*, +precipitation_04,precipitation_04,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Apr,P Apr,april,mm per month,*mm~mo^-1*, +precipitation_05,precipitation_05,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation May,P May,may,mm per month,*mm~mo^-1*, +precipitation_06,precipitation_06,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jun,P Jun,june,mm per month,*mm~mo^-1*, +precipitation_07,precipitation_07,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jul,P Jul,july,mm per month,*mm~mo^-1*, +precipitation_08,precipitation_08,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Aug,P Aug,august,mm per month,*mm~mo^-1*, +precipitation_09,precipitation_09,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Sep,P Sep,september,mm per month,*mm~mo^-1*, +precipitation_10,precipitation_10,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Oct,P Oct,october,mm per month,*mm~mo^-1*, +precipitation_11,precipitation_11,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Nov,P Nov,november,mm per month,*mm~mo^-1*, +precipitation_12,precipitation_12,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Dec,P Dec,december,mm per month,*mm~mo^-1*, +temperature_min_01,temperature_min_01,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jan,min T Jan,january,degrees Celsius,*degree*C*, +temperature_min_02,temperature_min_02,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Feb,min T Feb,february,degrees Celsius,*degree*C*, +temperature_min_03,temperature_min_03,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Mar,min T Mar,march,degrees Celsius,*degree*C*, +temperature_min_04,temperature_min_04,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Apr,min T Apr,april,degrees Celsius,*degree*C*, +temperature_min_05,temperature_min_05,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature May,min T May,may,degrees Celsius,*degree*C*, +temperature_min_06,temperature_min_06,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jun,min T Jun,june,degrees Celsius,*degree*C*, +temperature_min_07,temperature_min_07,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jul,min T Jul,july,degrees Celsius,*degree*C*, +temperature_min_08,temperature_min_08,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Aug,min T Aug,august,degrees Celsius,*degree*C*, +temperature_min_09,temperature_min_09,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Sep,min T Sep,september,degrees Celsius,*degree*C*, +temperature_min_10,temperature_min_10,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Oct,min T Oct,october,degrees Celsius,*degree*C*, +temperature_min_11,temperature_min_11,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Nov,min T Nov,november,degrees Celsius,*degree*C*, +temperature_min_12,temperature_min_12,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Dec,min T Dec,december,degrees Celsius,*degree*C*, +temperature_max_01,temperature_max_01,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jan,max T Jan,january,degrees Celsius,*degree*C*, +temperature_max_02,temperature_max_02,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Feb,max T Feb,february,degrees Celsius,*degree*C*, +temperature_max_03,temperature_max_03,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Mar,max T Mar,march,degrees Celsius,*degree*C*, +temperature_max_04,temperature_max_04,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Apr,max T Apr,april,degrees Celsius,*degree*C*, +temperature_max_05,temperature_max_05,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature May,max T May,may,degrees Celsius,*degree*C*, +temperature_max_06,temperature_max_06,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jun,max T Jun,june,degrees Celsius,*degree*C*, +temperature_max_07,temperature_max_07,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jul,max T Jul,july,degrees Celsius,*degree*C*, +temperature_max_08,temperature_max_08,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Aug,max T Aug,august,degrees Celsius,*degree*C*, +temperature_max_09,temperature_max_09,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Sep,max T Sep,september,degrees Celsius,*degree*C*, +temperature_max_10,temperature_max_10,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Oct,max T Oct,october,degrees Celsius,*degree*C*, +temperature_max_11,temperature_max_11,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Nov,max T Nov,november,degrees Celsius,*degree*C*, +temperature_max_12,temperature_max_12,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Dec,max T Dec,december,degrees Celsius,*degree*C*, +bio01,bio01,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual mean temperature,ann. mean T,year,degrees Celsius,*degree*C*, +bio02,bio02,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean diurnal range,diurn. range,year,degrees Celsius,*degree*C*, +bio03,bio03,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,isothermality,isothermality,year,,, +bio04,bio04,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature seasonality,T season.,year,degrees Celsius,*degree*C*, +bio05,bio05,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature of warmest month,max. T of warmest mo.,year,degrees Celsius,*degree*C*, +bio06,bio06,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature of coldest month,min. T of coldest mo.,year,degrees Celsius,*degree*C*, +bio07,bio07,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature annual range (bio05-bio06),T ann. Range,year,degrees Celsius,*degree*C*, +bio08,bio08,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of wettest quarter,mean T of wettest qtr,year,degrees Celsius,*degree*C*, +bio09,bio09,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of driest quarter,mean T of driest qtr,year,degrees Celsius,*degree*C*, +bio10,bio10,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of warmest quarter,mean T of warmest qtr,year,degrees Celsius,*degree*C*, +bio11,bio11,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of coldest quarter,mean T of coldest qtr,year,degrees Celsius,*degree*C*, +bio12,bio12,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual precipitation,ann. P,year,mm per year,*mm~yr^-1*, +bio13,bio13,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest month,P of wettest mo.,year,mm per month,*mm~mo^-1*, +bio14,bio14,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest month,P of driest mo.,year,mm per month,*mm~mo^-1*, +bio15,bio15,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation seasonality (coeff var),P season.,year,,, +bio16,bio16,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest quarter,P of wettest qtr,year,mm per quarter,*mm~qtr^-1*, +bio17,bio17,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest quarter,P of driest qtr,year,mm per quarter,*mm~qtr^-1*, +bio18,bio18,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of warmest quarter,P of warmest qtr,year,mm per quarter,*mm~qtr^-1*, +bio19,bio19,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m,FALSE,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of coldest quarter,P of coldest qtr,year,mm per quarter,*mm~qtr^-1*, +precipitation_01,precipitation_01,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jan,P Jan,january,mm per month,*mm~mo^-1*, +precipitation_02,precipitation_02,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Feb,P Feb,february,mm per month,*mm~mo^-1*, +precipitation_03,precipitation_03,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Mar,P Mar,march,mm per month,*mm~mo^-1*, +precipitation_04,precipitation_04,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Apr,P Apr,april,mm per month,*mm~mo^-1*, +precipitation_05,precipitation_05,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation May,P May,may,mm per month,*mm~mo^-1*, +precipitation_06,precipitation_06,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jun,P Jun,june,mm per month,*mm~mo^-1*, +precipitation_07,precipitation_07,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jul,P Jul,july,mm per month,*mm~mo^-1*, +precipitation_08,precipitation_08,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Aug,P Aug,august,mm per month,*mm~mo^-1*, +precipitation_09,precipitation_09,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Sep,P Sep,september,mm per month,*mm~mo^-1*, +precipitation_10,precipitation_10,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Oct,P Oct,october,mm per month,*mm~mo^-1*, +precipitation_11,precipitation_11,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Nov,P Nov,november,mm per month,*mm~mo^-1*, +precipitation_12,precipitation_12,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Dec,P Dec,december,mm per month,*mm~mo^-1*, +temperature_min_01,temperature_min_01,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jan,min T Jan,january,degrees Celsius,*degree*C*, +temperature_min_02,temperature_min_02,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Feb,min T Feb,february,degrees Celsius,*degree*C*, +temperature_min_03,temperature_min_03,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Mar,min T Mar,march,degrees Celsius,*degree*C*, +temperature_min_04,temperature_min_04,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Apr,min T Apr,april,degrees Celsius,*degree*C*, +temperature_min_05,temperature_min_05,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature May,min T May,may,degrees Celsius,*degree*C*, +temperature_min_06,temperature_min_06,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jun,min T Jun,june,degrees Celsius,*degree*C*, +temperature_min_07,temperature_min_07,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jul,min T Jul,july,degrees Celsius,*degree*C*, +temperature_min_08,temperature_min_08,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Aug,min T Aug,august,degrees Celsius,*degree*C*, +temperature_min_09,temperature_min_09,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Sep,min T Sep,september,degrees Celsius,*degree*C*, +temperature_min_10,temperature_min_10,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Oct,min T Oct,october,degrees Celsius,*degree*C*, +temperature_min_11,temperature_min_11,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Nov,min T Nov,november,degrees Celsius,*degree*C*, +temperature_min_12,temperature_min_12,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Dec,min T Dec,december,degrees Celsius,*degree*C*, +temperature_max_01,temperature_max_01,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jan,max T Jan,january,degrees Celsius,*degree*C*, +temperature_max_02,temperature_max_02,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Feb,max T Feb,february,degrees Celsius,*degree*C*, +temperature_max_03,temperature_max_03,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Mar,max T Mar,march,degrees Celsius,*degree*C*, +temperature_max_04,temperature_max_04,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Apr,max T Apr,april,degrees Celsius,*degree*C*, +temperature_max_05,temperature_max_05,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature May,max T May,may,degrees Celsius,*degree*C*, +temperature_max_06,temperature_max_06,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jun,max T Jun,june,degrees Celsius,*degree*C*, +temperature_max_07,temperature_max_07,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jul,max T Jul,july,degrees Celsius,*degree*C*, +temperature_max_08,temperature_max_08,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Aug,max T Aug,august,degrees Celsius,*degree*C*, +temperature_max_09,temperature_max_09,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Sep,max T Sep,september,degrees Celsius,*degree*C*, +temperature_max_10,temperature_max_10,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Oct,max T Oct,october,degrees Celsius,*degree*C*, +temperature_max_11,temperature_max_11,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Nov,max T Nov,november,degrees Celsius,*degree*C*, +temperature_max_12,temperature_max_12,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m,TRUE,WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Dec,max T Dec,december,degrees Celsius,*degree*C*, +bio01,bio01,WorldClim_2.1_MRI-ESM2-0_ssp126_10m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual mean temperature,ann. mean T,year,degrees Celsius,*degree*C*, +bio02,bio02,WorldClim_2.1_MRI-ESM2-0_ssp126_10m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean diurnal range,diurn. range,year,degrees Celsius,*degree*C*, +bio03,bio03,WorldClim_2.1_MRI-ESM2-0_ssp126_10m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,isothermality,isothermality,year,,, +bio04,bio04,WorldClim_2.1_MRI-ESM2-0_ssp126_10m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature seasonality,T season.,year,degrees Celsius,*degree*C*, +bio05,bio05,WorldClim_2.1_MRI-ESM2-0_ssp126_10m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature of warmest month,max. T of warmest mo.,year,degrees Celsius,*degree*C*, +bio06,bio06,WorldClim_2.1_MRI-ESM2-0_ssp126_10m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature of coldest month,min. T of coldest mo.,year,degrees Celsius,*degree*C*, +bio07,bio07,WorldClim_2.1_MRI-ESM2-0_ssp126_10m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature annual range (bio05-bio06),T ann. Range,year,degrees Celsius,*degree*C*, +bio08,bio08,WorldClim_2.1_MRI-ESM2-0_ssp126_10m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of wettest quarter,mean T of wettest qtr,year,degrees Celsius,*degree*C*, +bio09,bio09,WorldClim_2.1_MRI-ESM2-0_ssp126_10m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of driest quarter,mean T of driest qtr,year,degrees Celsius,*degree*C*, +bio10,bio10,WorldClim_2.1_MRI-ESM2-0_ssp126_10m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of warmest quarter,mean T of warmest qtr,year,degrees Celsius,*degree*C*, +bio11,bio11,WorldClim_2.1_MRI-ESM2-0_ssp126_10m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of coldest quarter,mean T of coldest qtr,year,degrees Celsius,*degree*C*, +bio12,bio12,WorldClim_2.1_MRI-ESM2-0_ssp126_10m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual precipitation,ann. P,year,mm per year,*mm~yr^-1*, +bio13,bio13,WorldClim_2.1_MRI-ESM2-0_ssp126_10m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest month,P of wettest mo.,year,mm per month,*mm~mo^-1*, +bio14,bio14,WorldClim_2.1_MRI-ESM2-0_ssp126_10m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest month,P of driest mo.,year,mm per month,*mm~mo^-1*, +bio15,bio15,WorldClim_2.1_MRI-ESM2-0_ssp126_10m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation seasonality (coeff var),P season.,year,,, +bio16,bio16,WorldClim_2.1_MRI-ESM2-0_ssp126_10m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest quarter,P of wettest qtr,year,mm per quarter,*mm~qtr^-1*, +bio17,bio17,WorldClim_2.1_MRI-ESM2-0_ssp126_10m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest quarter,P of driest qtr,year,mm per quarter,*mm~qtr^-1*, +bio18,bio18,WorldClim_2.1_MRI-ESM2-0_ssp126_10m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of warmest quarter,P of warmest qtr,year,mm per quarter,*mm~qtr^-1*, +bio19,bio19,WorldClim_2.1_MRI-ESM2-0_ssp126_10m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of coldest quarter,P of coldest qtr,year,mm per quarter,*mm~qtr^-1*, +precipitation_01,precipitation_01,WorldClim_2.1_MRI-ESM2-0_ssp126_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jan,P Jan,january,mm per month,*mm~mo^-1*, +precipitation_02,precipitation_02,WorldClim_2.1_MRI-ESM2-0_ssp126_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Feb,P Feb,february,mm per month,*mm~mo^-1*, +precipitation_03,precipitation_03,WorldClim_2.1_MRI-ESM2-0_ssp126_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Mar,P Mar,march,mm per month,*mm~mo^-1*, +precipitation_04,precipitation_04,WorldClim_2.1_MRI-ESM2-0_ssp126_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Apr,P Apr,april,mm per month,*mm~mo^-1*, +precipitation_05,precipitation_05,WorldClim_2.1_MRI-ESM2-0_ssp126_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation May,P May,may,mm per month,*mm~mo^-1*, +precipitation_06,precipitation_06,WorldClim_2.1_MRI-ESM2-0_ssp126_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jun,P Jun,june,mm per month,*mm~mo^-1*, +precipitation_07,precipitation_07,WorldClim_2.1_MRI-ESM2-0_ssp126_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jul,P Jul,july,mm per month,*mm~mo^-1*, +precipitation_08,precipitation_08,WorldClim_2.1_MRI-ESM2-0_ssp126_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Aug,P Aug,august,mm per month,*mm~mo^-1*, +precipitation_09,precipitation_09,WorldClim_2.1_MRI-ESM2-0_ssp126_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Sep,P Sep,september,mm per month,*mm~mo^-1*, +precipitation_10,precipitation_10,WorldClim_2.1_MRI-ESM2-0_ssp126_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Oct,P Oct,october,mm per month,*mm~mo^-1*, +precipitation_11,precipitation_11,WorldClim_2.1_MRI-ESM2-0_ssp126_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Nov,P Nov,november,mm per month,*mm~mo^-1*, +precipitation_12,precipitation_12,WorldClim_2.1_MRI-ESM2-0_ssp126_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Dec,P Dec,december,mm per month,*mm~mo^-1*, +temperature_min_01,temperature_min_01,WorldClim_2.1_MRI-ESM2-0_ssp126_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jan,min T Jan,january,degrees Celsius,*degree*C*, +temperature_min_02,temperature_min_02,WorldClim_2.1_MRI-ESM2-0_ssp126_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Feb,min T Feb,february,degrees Celsius,*degree*C*, +temperature_min_03,temperature_min_03,WorldClim_2.1_MRI-ESM2-0_ssp126_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Mar,min T Mar,march,degrees Celsius,*degree*C*, +temperature_min_04,temperature_min_04,WorldClim_2.1_MRI-ESM2-0_ssp126_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Apr,min T Apr,april,degrees Celsius,*degree*C*, +temperature_min_05,temperature_min_05,WorldClim_2.1_MRI-ESM2-0_ssp126_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature May,min T May,may,degrees Celsius,*degree*C*, +temperature_min_06,temperature_min_06,WorldClim_2.1_MRI-ESM2-0_ssp126_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jun,min T Jun,june,degrees Celsius,*degree*C*, +temperature_min_07,temperature_min_07,WorldClim_2.1_MRI-ESM2-0_ssp126_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jul,min T Jul,july,degrees Celsius,*degree*C*, +temperature_min_08,temperature_min_08,WorldClim_2.1_MRI-ESM2-0_ssp126_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Aug,min T Aug,august,degrees Celsius,*degree*C*, +temperature_min_09,temperature_min_09,WorldClim_2.1_MRI-ESM2-0_ssp126_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Sep,min T Sep,september,degrees Celsius,*degree*C*, +temperature_min_10,temperature_min_10,WorldClim_2.1_MRI-ESM2-0_ssp126_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Oct,min T Oct,october,degrees Celsius,*degree*C*, +temperature_min_11,temperature_min_11,WorldClim_2.1_MRI-ESM2-0_ssp126_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Nov,min T Nov,november,degrees Celsius,*degree*C*, +temperature_min_12,temperature_min_12,WorldClim_2.1_MRI-ESM2-0_ssp126_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Dec,min T Dec,december,degrees Celsius,*degree*C*, +temperature_max_01,temperature_max_01,WorldClim_2.1_MRI-ESM2-0_ssp126_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jan,max T Jan,january,degrees Celsius,*degree*C*, +temperature_max_02,temperature_max_02,WorldClim_2.1_MRI-ESM2-0_ssp126_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Feb,max T Feb,february,degrees Celsius,*degree*C*, +temperature_max_03,temperature_max_03,WorldClim_2.1_MRI-ESM2-0_ssp126_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Mar,max T Mar,march,degrees Celsius,*degree*C*, +temperature_max_04,temperature_max_04,WorldClim_2.1_MRI-ESM2-0_ssp126_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Apr,max T Apr,april,degrees Celsius,*degree*C*, +temperature_max_05,temperature_max_05,WorldClim_2.1_MRI-ESM2-0_ssp126_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature May,max T May,may,degrees Celsius,*degree*C*, +temperature_max_06,temperature_max_06,WorldClim_2.1_MRI-ESM2-0_ssp126_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jun,max T Jun,june,degrees Celsius,*degree*C*, +temperature_max_07,temperature_max_07,WorldClim_2.1_MRI-ESM2-0_ssp126_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jul,max T Jul,july,degrees Celsius,*degree*C*, +temperature_max_08,temperature_max_08,WorldClim_2.1_MRI-ESM2-0_ssp126_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Aug,max T Aug,august,degrees Celsius,*degree*C*, +temperature_max_09,temperature_max_09,WorldClim_2.1_MRI-ESM2-0_ssp126_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Sep,max T Sep,september,degrees Celsius,*degree*C*, +temperature_max_10,temperature_max_10,WorldClim_2.1_MRI-ESM2-0_ssp126_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Oct,max T Oct,october,degrees Celsius,*degree*C*, +temperature_max_11,temperature_max_11,WorldClim_2.1_MRI-ESM2-0_ssp126_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Nov,max T Nov,november,degrees Celsius,*degree*C*, +temperature_max_12,temperature_max_12,WorldClim_2.1_MRI-ESM2-0_ssp126_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Dec,max T Dec,december,degrees Celsius,*degree*C*, +bio01,bio01,WorldClim_2.1_MRI-ESM2-0_ssp126_5m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual mean temperature,ann. mean T,year,degrees Celsius,*degree*C*, +bio02,bio02,WorldClim_2.1_MRI-ESM2-0_ssp126_5m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean diurnal range,diurn. range,year,degrees Celsius,*degree*C*, +bio03,bio03,WorldClim_2.1_MRI-ESM2-0_ssp126_5m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,isothermality,isothermality,year,,, +bio04,bio04,WorldClim_2.1_MRI-ESM2-0_ssp126_5m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature seasonality,T season.,year,degrees Celsius,*degree*C*, +bio05,bio05,WorldClim_2.1_MRI-ESM2-0_ssp126_5m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature of warmest month,max. T of warmest mo.,year,degrees Celsius,*degree*C*, +bio06,bio06,WorldClim_2.1_MRI-ESM2-0_ssp126_5m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature of coldest month,min. T of coldest mo.,year,degrees Celsius,*degree*C*, +bio07,bio07,WorldClim_2.1_MRI-ESM2-0_ssp126_5m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature annual range (bio05-bio06),T ann. Range,year,degrees Celsius,*degree*C*, +bio08,bio08,WorldClim_2.1_MRI-ESM2-0_ssp126_5m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of wettest quarter,mean T of wettest qtr,year,degrees Celsius,*degree*C*, +bio09,bio09,WorldClim_2.1_MRI-ESM2-0_ssp126_5m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of driest quarter,mean T of driest qtr,year,degrees Celsius,*degree*C*, +bio10,bio10,WorldClim_2.1_MRI-ESM2-0_ssp126_5m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of warmest quarter,mean T of warmest qtr,year,degrees Celsius,*degree*C*, +bio11,bio11,WorldClim_2.1_MRI-ESM2-0_ssp126_5m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of coldest quarter,mean T of coldest qtr,year,degrees Celsius,*degree*C*, +bio12,bio12,WorldClim_2.1_MRI-ESM2-0_ssp126_5m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual precipitation,ann. P,year,mm per year,*mm~yr^-1*, +bio13,bio13,WorldClim_2.1_MRI-ESM2-0_ssp126_5m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest month,P of wettest mo.,year,mm per month,*mm~mo^-1*, +bio14,bio14,WorldClim_2.1_MRI-ESM2-0_ssp126_5m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest month,P of driest mo.,year,mm per month,*mm~mo^-1*, +bio15,bio15,WorldClim_2.1_MRI-ESM2-0_ssp126_5m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation seasonality (coeff var),P season.,year,,, +bio16,bio16,WorldClim_2.1_MRI-ESM2-0_ssp126_5m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest quarter,P of wettest qtr,year,mm per quarter,*mm~qtr^-1*, +bio17,bio17,WorldClim_2.1_MRI-ESM2-0_ssp126_5m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest quarter,P of driest qtr,year,mm per quarter,*mm~qtr^-1*, +bio18,bio18,WorldClim_2.1_MRI-ESM2-0_ssp126_5m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of warmest quarter,P of warmest qtr,year,mm per quarter,*mm~qtr^-1*, +bio19,bio19,WorldClim_2.1_MRI-ESM2-0_ssp126_5m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of coldest quarter,P of coldest qtr,year,mm per quarter,*mm~qtr^-1*, +precipitation_01,precipitation_01,WorldClim_2.1_MRI-ESM2-0_ssp126_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jan,P Jan,january,mm per month,*mm~mo^-1*, +precipitation_02,precipitation_02,WorldClim_2.1_MRI-ESM2-0_ssp126_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Feb,P Feb,february,mm per month,*mm~mo^-1*, +precipitation_03,precipitation_03,WorldClim_2.1_MRI-ESM2-0_ssp126_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Mar,P Mar,march,mm per month,*mm~mo^-1*, +precipitation_04,precipitation_04,WorldClim_2.1_MRI-ESM2-0_ssp126_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Apr,P Apr,april,mm per month,*mm~mo^-1*, +precipitation_05,precipitation_05,WorldClim_2.1_MRI-ESM2-0_ssp126_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation May,P May,may,mm per month,*mm~mo^-1*, +precipitation_06,precipitation_06,WorldClim_2.1_MRI-ESM2-0_ssp126_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jun,P Jun,june,mm per month,*mm~mo^-1*, +precipitation_07,precipitation_07,WorldClim_2.1_MRI-ESM2-0_ssp126_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jul,P Jul,july,mm per month,*mm~mo^-1*, +precipitation_08,precipitation_08,WorldClim_2.1_MRI-ESM2-0_ssp126_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Aug,P Aug,august,mm per month,*mm~mo^-1*, +precipitation_09,precipitation_09,WorldClim_2.1_MRI-ESM2-0_ssp126_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Sep,P Sep,september,mm per month,*mm~mo^-1*, +precipitation_10,precipitation_10,WorldClim_2.1_MRI-ESM2-0_ssp126_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Oct,P Oct,october,mm per month,*mm~mo^-1*, +precipitation_11,precipitation_11,WorldClim_2.1_MRI-ESM2-0_ssp126_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Nov,P Nov,november,mm per month,*mm~mo^-1*, +precipitation_12,precipitation_12,WorldClim_2.1_MRI-ESM2-0_ssp126_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Dec,P Dec,december,mm per month,*mm~mo^-1*, +temperature_min_01,temperature_min_01,WorldClim_2.1_MRI-ESM2-0_ssp126_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jan,min T Jan,january,degrees Celsius,*degree*C*, +temperature_min_02,temperature_min_02,WorldClim_2.1_MRI-ESM2-0_ssp126_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Feb,min T Feb,february,degrees Celsius,*degree*C*, +temperature_min_03,temperature_min_03,WorldClim_2.1_MRI-ESM2-0_ssp126_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Mar,min T Mar,march,degrees Celsius,*degree*C*, +temperature_min_04,temperature_min_04,WorldClim_2.1_MRI-ESM2-0_ssp126_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Apr,min T Apr,april,degrees Celsius,*degree*C*, +temperature_min_05,temperature_min_05,WorldClim_2.1_MRI-ESM2-0_ssp126_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature May,min T May,may,degrees Celsius,*degree*C*, +temperature_min_06,temperature_min_06,WorldClim_2.1_MRI-ESM2-0_ssp126_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jun,min T Jun,june,degrees Celsius,*degree*C*, +temperature_min_07,temperature_min_07,WorldClim_2.1_MRI-ESM2-0_ssp126_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jul,min T Jul,july,degrees Celsius,*degree*C*, +temperature_min_08,temperature_min_08,WorldClim_2.1_MRI-ESM2-0_ssp126_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Aug,min T Aug,august,degrees Celsius,*degree*C*, +temperature_min_09,temperature_min_09,WorldClim_2.1_MRI-ESM2-0_ssp126_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Sep,min T Sep,september,degrees Celsius,*degree*C*, +temperature_min_10,temperature_min_10,WorldClim_2.1_MRI-ESM2-0_ssp126_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Oct,min T Oct,october,degrees Celsius,*degree*C*, +temperature_min_11,temperature_min_11,WorldClim_2.1_MRI-ESM2-0_ssp126_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Nov,min T Nov,november,degrees Celsius,*degree*C*, +temperature_min_12,temperature_min_12,WorldClim_2.1_MRI-ESM2-0_ssp126_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Dec,min T Dec,december,degrees Celsius,*degree*C*, +temperature_max_01,temperature_max_01,WorldClim_2.1_MRI-ESM2-0_ssp126_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jan,max T Jan,january,degrees Celsius,*degree*C*, +temperature_max_02,temperature_max_02,WorldClim_2.1_MRI-ESM2-0_ssp126_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Feb,max T Feb,february,degrees Celsius,*degree*C*, +temperature_max_03,temperature_max_03,WorldClim_2.1_MRI-ESM2-0_ssp126_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Mar,max T Mar,march,degrees Celsius,*degree*C*, +temperature_max_04,temperature_max_04,WorldClim_2.1_MRI-ESM2-0_ssp126_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Apr,max T Apr,april,degrees Celsius,*degree*C*, +temperature_max_05,temperature_max_05,WorldClim_2.1_MRI-ESM2-0_ssp126_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature May,max T May,may,degrees Celsius,*degree*C*, +temperature_max_06,temperature_max_06,WorldClim_2.1_MRI-ESM2-0_ssp126_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jun,max T Jun,june,degrees Celsius,*degree*C*, +temperature_max_07,temperature_max_07,WorldClim_2.1_MRI-ESM2-0_ssp126_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jul,max T Jul,july,degrees Celsius,*degree*C*, +temperature_max_08,temperature_max_08,WorldClim_2.1_MRI-ESM2-0_ssp126_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Aug,max T Aug,august,degrees Celsius,*degree*C*, +temperature_max_09,temperature_max_09,WorldClim_2.1_MRI-ESM2-0_ssp126_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Sep,max T Sep,september,degrees Celsius,*degree*C*, +temperature_max_10,temperature_max_10,WorldClim_2.1_MRI-ESM2-0_ssp126_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Oct,max T Oct,october,degrees Celsius,*degree*C*, +temperature_max_11,temperature_max_11,WorldClim_2.1_MRI-ESM2-0_ssp126_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Nov,max T Nov,november,degrees Celsius,*degree*C*, +temperature_max_12,temperature_max_12,WorldClim_2.1_MRI-ESM2-0_ssp126_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Dec,max T Dec,december,degrees Celsius,*degree*C*, +bio01,bio01,WorldClim_2.1_MRI-ESM2-0_ssp245_10m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual mean temperature,ann. mean T,year,degrees Celsius,*degree*C*, +bio02,bio02,WorldClim_2.1_MRI-ESM2-0_ssp245_10m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean diurnal range,diurn. range,year,degrees Celsius,*degree*C*, +bio03,bio03,WorldClim_2.1_MRI-ESM2-0_ssp245_10m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,isothermality,isothermality,year,,, +bio04,bio04,WorldClim_2.1_MRI-ESM2-0_ssp245_10m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature seasonality,T season.,year,degrees Celsius,*degree*C*, +bio05,bio05,WorldClim_2.1_MRI-ESM2-0_ssp245_10m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature of warmest month,max. T of warmest mo.,year,degrees Celsius,*degree*C*, +bio06,bio06,WorldClim_2.1_MRI-ESM2-0_ssp245_10m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature of coldest month,min. T of coldest mo.,year,degrees Celsius,*degree*C*, +bio07,bio07,WorldClim_2.1_MRI-ESM2-0_ssp245_10m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature annual range (bio05-bio06),T ann. Range,year,degrees Celsius,*degree*C*, +bio08,bio08,WorldClim_2.1_MRI-ESM2-0_ssp245_10m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of wettest quarter,mean T of wettest qtr,year,degrees Celsius,*degree*C*, +bio09,bio09,WorldClim_2.1_MRI-ESM2-0_ssp245_10m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of driest quarter,mean T of driest qtr,year,degrees Celsius,*degree*C*, +bio10,bio10,WorldClim_2.1_MRI-ESM2-0_ssp245_10m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of warmest quarter,mean T of warmest qtr,year,degrees Celsius,*degree*C*, +bio11,bio11,WorldClim_2.1_MRI-ESM2-0_ssp245_10m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of coldest quarter,mean T of coldest qtr,year,degrees Celsius,*degree*C*, +bio12,bio12,WorldClim_2.1_MRI-ESM2-0_ssp245_10m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual precipitation,ann. P,year,mm per year,*mm~yr^-1*, +bio13,bio13,WorldClim_2.1_MRI-ESM2-0_ssp245_10m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest month,P of wettest mo.,year,mm per month,*mm~mo^-1*, +bio14,bio14,WorldClim_2.1_MRI-ESM2-0_ssp245_10m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest month,P of driest mo.,year,mm per month,*mm~mo^-1*, +bio15,bio15,WorldClim_2.1_MRI-ESM2-0_ssp245_10m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation seasonality (coeff var),P season.,year,,, +bio16,bio16,WorldClim_2.1_MRI-ESM2-0_ssp245_10m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest quarter,P of wettest qtr,year,mm per quarter,*mm~qtr^-1*, +bio17,bio17,WorldClim_2.1_MRI-ESM2-0_ssp245_10m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest quarter,P of driest qtr,year,mm per quarter,*mm~qtr^-1*, +bio18,bio18,WorldClim_2.1_MRI-ESM2-0_ssp245_10m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of warmest quarter,P of warmest qtr,year,mm per quarter,*mm~qtr^-1*, +bio19,bio19,WorldClim_2.1_MRI-ESM2-0_ssp245_10m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of coldest quarter,P of coldest qtr,year,mm per quarter,*mm~qtr^-1*, +precipitation_01,precipitation_01,WorldClim_2.1_MRI-ESM2-0_ssp245_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jan,P Jan,january,mm per month,*mm~mo^-1*, +precipitation_02,precipitation_02,WorldClim_2.1_MRI-ESM2-0_ssp245_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Feb,P Feb,february,mm per month,*mm~mo^-1*, +precipitation_03,precipitation_03,WorldClim_2.1_MRI-ESM2-0_ssp245_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Mar,P Mar,march,mm per month,*mm~mo^-1*, +precipitation_04,precipitation_04,WorldClim_2.1_MRI-ESM2-0_ssp245_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Apr,P Apr,april,mm per month,*mm~mo^-1*, +precipitation_05,precipitation_05,WorldClim_2.1_MRI-ESM2-0_ssp245_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation May,P May,may,mm per month,*mm~mo^-1*, +precipitation_06,precipitation_06,WorldClim_2.1_MRI-ESM2-0_ssp245_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jun,P Jun,june,mm per month,*mm~mo^-1*, +precipitation_07,precipitation_07,WorldClim_2.1_MRI-ESM2-0_ssp245_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jul,P Jul,july,mm per month,*mm~mo^-1*, +precipitation_08,precipitation_08,WorldClim_2.1_MRI-ESM2-0_ssp245_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Aug,P Aug,august,mm per month,*mm~mo^-1*, +precipitation_09,precipitation_09,WorldClim_2.1_MRI-ESM2-0_ssp245_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Sep,P Sep,september,mm per month,*mm~mo^-1*, +precipitation_10,precipitation_10,WorldClim_2.1_MRI-ESM2-0_ssp245_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Oct,P Oct,october,mm per month,*mm~mo^-1*, +precipitation_11,precipitation_11,WorldClim_2.1_MRI-ESM2-0_ssp245_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Nov,P Nov,november,mm per month,*mm~mo^-1*, +precipitation_12,precipitation_12,WorldClim_2.1_MRI-ESM2-0_ssp245_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Dec,P Dec,december,mm per month,*mm~mo^-1*, +temperature_min_01,temperature_min_01,WorldClim_2.1_MRI-ESM2-0_ssp245_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jan,min T Jan,january,degrees Celsius,*degree*C*, +temperature_min_02,temperature_min_02,WorldClim_2.1_MRI-ESM2-0_ssp245_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Feb,min T Feb,february,degrees Celsius,*degree*C*, +temperature_min_03,temperature_min_03,WorldClim_2.1_MRI-ESM2-0_ssp245_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Mar,min T Mar,march,degrees Celsius,*degree*C*, +temperature_min_04,temperature_min_04,WorldClim_2.1_MRI-ESM2-0_ssp245_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Apr,min T Apr,april,degrees Celsius,*degree*C*, +temperature_min_05,temperature_min_05,WorldClim_2.1_MRI-ESM2-0_ssp245_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature May,min T May,may,degrees Celsius,*degree*C*, +temperature_min_06,temperature_min_06,WorldClim_2.1_MRI-ESM2-0_ssp245_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jun,min T Jun,june,degrees Celsius,*degree*C*, +temperature_min_07,temperature_min_07,WorldClim_2.1_MRI-ESM2-0_ssp245_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jul,min T Jul,july,degrees Celsius,*degree*C*, +temperature_min_08,temperature_min_08,WorldClim_2.1_MRI-ESM2-0_ssp245_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Aug,min T Aug,august,degrees Celsius,*degree*C*, +temperature_min_09,temperature_min_09,WorldClim_2.1_MRI-ESM2-0_ssp245_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Sep,min T Sep,september,degrees Celsius,*degree*C*, +temperature_min_10,temperature_min_10,WorldClim_2.1_MRI-ESM2-0_ssp245_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Oct,min T Oct,october,degrees Celsius,*degree*C*, +temperature_min_11,temperature_min_11,WorldClim_2.1_MRI-ESM2-0_ssp245_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Nov,min T Nov,november,degrees Celsius,*degree*C*, +temperature_min_12,temperature_min_12,WorldClim_2.1_MRI-ESM2-0_ssp245_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Dec,min T Dec,december,degrees Celsius,*degree*C*, +temperature_max_01,temperature_max_01,WorldClim_2.1_MRI-ESM2-0_ssp245_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jan,max T Jan,january,degrees Celsius,*degree*C*, +temperature_max_02,temperature_max_02,WorldClim_2.1_MRI-ESM2-0_ssp245_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Feb,max T Feb,february,degrees Celsius,*degree*C*, +temperature_max_03,temperature_max_03,WorldClim_2.1_MRI-ESM2-0_ssp245_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Mar,max T Mar,march,degrees Celsius,*degree*C*, +temperature_max_04,temperature_max_04,WorldClim_2.1_MRI-ESM2-0_ssp245_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Apr,max T Apr,april,degrees Celsius,*degree*C*, +temperature_max_05,temperature_max_05,WorldClim_2.1_MRI-ESM2-0_ssp245_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature May,max T May,may,degrees Celsius,*degree*C*, +temperature_max_06,temperature_max_06,WorldClim_2.1_MRI-ESM2-0_ssp245_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jun,max T Jun,june,degrees Celsius,*degree*C*, +temperature_max_07,temperature_max_07,WorldClim_2.1_MRI-ESM2-0_ssp245_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jul,max T Jul,july,degrees Celsius,*degree*C*, +temperature_max_08,temperature_max_08,WorldClim_2.1_MRI-ESM2-0_ssp245_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Aug,max T Aug,august,degrees Celsius,*degree*C*, +temperature_max_09,temperature_max_09,WorldClim_2.1_MRI-ESM2-0_ssp245_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Sep,max T Sep,september,degrees Celsius,*degree*C*, +temperature_max_10,temperature_max_10,WorldClim_2.1_MRI-ESM2-0_ssp245_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Oct,max T Oct,october,degrees Celsius,*degree*C*, +temperature_max_11,temperature_max_11,WorldClim_2.1_MRI-ESM2-0_ssp245_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Nov,max T Nov,november,degrees Celsius,*degree*C*, +temperature_max_12,temperature_max_12,WorldClim_2.1_MRI-ESM2-0_ssp245_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Dec,max T Dec,december,degrees Celsius,*degree*C*, +bio01,bio01,WorldClim_2.1_MRI-ESM2-0_ssp245_5m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual mean temperature,ann. mean T,year,degrees Celsius,*degree*C*, +bio02,bio02,WorldClim_2.1_MRI-ESM2-0_ssp245_5m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean diurnal range,diurn. range,year,degrees Celsius,*degree*C*, +bio03,bio03,WorldClim_2.1_MRI-ESM2-0_ssp245_5m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,isothermality,isothermality,year,,, +bio04,bio04,WorldClim_2.1_MRI-ESM2-0_ssp245_5m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature seasonality,T season.,year,degrees Celsius,*degree*C*, +bio05,bio05,WorldClim_2.1_MRI-ESM2-0_ssp245_5m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature of warmest month,max. T of warmest mo.,year,degrees Celsius,*degree*C*, +bio06,bio06,WorldClim_2.1_MRI-ESM2-0_ssp245_5m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature of coldest month,min. T of coldest mo.,year,degrees Celsius,*degree*C*, +bio07,bio07,WorldClim_2.1_MRI-ESM2-0_ssp245_5m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature annual range (bio05-bio06),T ann. Range,year,degrees Celsius,*degree*C*, +bio08,bio08,WorldClim_2.1_MRI-ESM2-0_ssp245_5m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of wettest quarter,mean T of wettest qtr,year,degrees Celsius,*degree*C*, +bio09,bio09,WorldClim_2.1_MRI-ESM2-0_ssp245_5m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of driest quarter,mean T of driest qtr,year,degrees Celsius,*degree*C*, +bio10,bio10,WorldClim_2.1_MRI-ESM2-0_ssp245_5m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of warmest quarter,mean T of warmest qtr,year,degrees Celsius,*degree*C*, +bio11,bio11,WorldClim_2.1_MRI-ESM2-0_ssp245_5m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of coldest quarter,mean T of coldest qtr,year,degrees Celsius,*degree*C*, +bio12,bio12,WorldClim_2.1_MRI-ESM2-0_ssp245_5m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual precipitation,ann. P,year,mm per year,*mm~yr^-1*, +bio13,bio13,WorldClim_2.1_MRI-ESM2-0_ssp245_5m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest month,P of wettest mo.,year,mm per month,*mm~mo^-1*, +bio14,bio14,WorldClim_2.1_MRI-ESM2-0_ssp245_5m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest month,P of driest mo.,year,mm per month,*mm~mo^-1*, +bio15,bio15,WorldClim_2.1_MRI-ESM2-0_ssp245_5m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation seasonality (coeff var),P season.,year,,, +bio16,bio16,WorldClim_2.1_MRI-ESM2-0_ssp245_5m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest quarter,P of wettest qtr,year,mm per quarter,*mm~qtr^-1*, +bio17,bio17,WorldClim_2.1_MRI-ESM2-0_ssp245_5m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest quarter,P of driest qtr,year,mm per quarter,*mm~qtr^-1*, +bio18,bio18,WorldClim_2.1_MRI-ESM2-0_ssp245_5m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of warmest quarter,P of warmest qtr,year,mm per quarter,*mm~qtr^-1*, +bio19,bio19,WorldClim_2.1_MRI-ESM2-0_ssp245_5m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of coldest quarter,P of coldest qtr,year,mm per quarter,*mm~qtr^-1*, +precipitation_01,precipitation_01,WorldClim_2.1_MRI-ESM2-0_ssp245_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jan,P Jan,january,mm per month,*mm~mo^-1*, +precipitation_02,precipitation_02,WorldClim_2.1_MRI-ESM2-0_ssp245_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Feb,P Feb,february,mm per month,*mm~mo^-1*, +precipitation_03,precipitation_03,WorldClim_2.1_MRI-ESM2-0_ssp245_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Mar,P Mar,march,mm per month,*mm~mo^-1*, +precipitation_04,precipitation_04,WorldClim_2.1_MRI-ESM2-0_ssp245_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Apr,P Apr,april,mm per month,*mm~mo^-1*, +precipitation_05,precipitation_05,WorldClim_2.1_MRI-ESM2-0_ssp245_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation May,P May,may,mm per month,*mm~mo^-1*, +precipitation_06,precipitation_06,WorldClim_2.1_MRI-ESM2-0_ssp245_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jun,P Jun,june,mm per month,*mm~mo^-1*, +precipitation_07,precipitation_07,WorldClim_2.1_MRI-ESM2-0_ssp245_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jul,P Jul,july,mm per month,*mm~mo^-1*, +precipitation_08,precipitation_08,WorldClim_2.1_MRI-ESM2-0_ssp245_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Aug,P Aug,august,mm per month,*mm~mo^-1*, +precipitation_09,precipitation_09,WorldClim_2.1_MRI-ESM2-0_ssp245_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Sep,P Sep,september,mm per month,*mm~mo^-1*, +precipitation_10,precipitation_10,WorldClim_2.1_MRI-ESM2-0_ssp245_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Oct,P Oct,october,mm per month,*mm~mo^-1*, +precipitation_11,precipitation_11,WorldClim_2.1_MRI-ESM2-0_ssp245_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Nov,P Nov,november,mm per month,*mm~mo^-1*, +precipitation_12,precipitation_12,WorldClim_2.1_MRI-ESM2-0_ssp245_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Dec,P Dec,december,mm per month,*mm~mo^-1*, +temperature_min_01,temperature_min_01,WorldClim_2.1_MRI-ESM2-0_ssp245_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jan,min T Jan,january,degrees Celsius,*degree*C*, +temperature_min_02,temperature_min_02,WorldClim_2.1_MRI-ESM2-0_ssp245_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Feb,min T Feb,february,degrees Celsius,*degree*C*, +temperature_min_03,temperature_min_03,WorldClim_2.1_MRI-ESM2-0_ssp245_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Mar,min T Mar,march,degrees Celsius,*degree*C*, +temperature_min_04,temperature_min_04,WorldClim_2.1_MRI-ESM2-0_ssp245_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Apr,min T Apr,april,degrees Celsius,*degree*C*, +temperature_min_05,temperature_min_05,WorldClim_2.1_MRI-ESM2-0_ssp245_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature May,min T May,may,degrees Celsius,*degree*C*, +temperature_min_06,temperature_min_06,WorldClim_2.1_MRI-ESM2-0_ssp245_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jun,min T Jun,june,degrees Celsius,*degree*C*, +temperature_min_07,temperature_min_07,WorldClim_2.1_MRI-ESM2-0_ssp245_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jul,min T Jul,july,degrees Celsius,*degree*C*, +temperature_min_08,temperature_min_08,WorldClim_2.1_MRI-ESM2-0_ssp245_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Aug,min T Aug,august,degrees Celsius,*degree*C*, +temperature_min_09,temperature_min_09,WorldClim_2.1_MRI-ESM2-0_ssp245_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Sep,min T Sep,september,degrees Celsius,*degree*C*, +temperature_min_10,temperature_min_10,WorldClim_2.1_MRI-ESM2-0_ssp245_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Oct,min T Oct,october,degrees Celsius,*degree*C*, +temperature_min_11,temperature_min_11,WorldClim_2.1_MRI-ESM2-0_ssp245_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Nov,min T Nov,november,degrees Celsius,*degree*C*, +temperature_min_12,temperature_min_12,WorldClim_2.1_MRI-ESM2-0_ssp245_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Dec,min T Dec,december,degrees Celsius,*degree*C*, +temperature_max_01,temperature_max_01,WorldClim_2.1_MRI-ESM2-0_ssp245_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jan,max T Jan,january,degrees Celsius,*degree*C*, +temperature_max_02,temperature_max_02,WorldClim_2.1_MRI-ESM2-0_ssp245_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Feb,max T Feb,february,degrees Celsius,*degree*C*, +temperature_max_03,temperature_max_03,WorldClim_2.1_MRI-ESM2-0_ssp245_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Mar,max T Mar,march,degrees Celsius,*degree*C*, +temperature_max_04,temperature_max_04,WorldClim_2.1_MRI-ESM2-0_ssp245_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Apr,max T Apr,april,degrees Celsius,*degree*C*, +temperature_max_05,temperature_max_05,WorldClim_2.1_MRI-ESM2-0_ssp245_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature May,max T May,may,degrees Celsius,*degree*C*, +temperature_max_06,temperature_max_06,WorldClim_2.1_MRI-ESM2-0_ssp245_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jun,max T Jun,june,degrees Celsius,*degree*C*, +temperature_max_07,temperature_max_07,WorldClim_2.1_MRI-ESM2-0_ssp245_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jul,max T Jul,july,degrees Celsius,*degree*C*, +temperature_max_08,temperature_max_08,WorldClim_2.1_MRI-ESM2-0_ssp245_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Aug,max T Aug,august,degrees Celsius,*degree*C*, +temperature_max_09,temperature_max_09,WorldClim_2.1_MRI-ESM2-0_ssp245_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Sep,max T Sep,september,degrees Celsius,*degree*C*, +temperature_max_10,temperature_max_10,WorldClim_2.1_MRI-ESM2-0_ssp245_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Oct,max T Oct,october,degrees Celsius,*degree*C*, +temperature_max_11,temperature_max_11,WorldClim_2.1_MRI-ESM2-0_ssp245_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Nov,max T Nov,november,degrees Celsius,*degree*C*, +temperature_max_12,temperature_max_12,WorldClim_2.1_MRI-ESM2-0_ssp245_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Dec,max T Dec,december,degrees Celsius,*degree*C*, +bio01,bio01,WorldClim_2.1_MRI-ESM2-0_ssp370_10m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual mean temperature,ann. mean T,year,degrees Celsius,*degree*C*, +bio02,bio02,WorldClim_2.1_MRI-ESM2-0_ssp370_10m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean diurnal range,diurn. range,year,degrees Celsius,*degree*C*, +bio03,bio03,WorldClim_2.1_MRI-ESM2-0_ssp370_10m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,isothermality,isothermality,year,,, +bio04,bio04,WorldClim_2.1_MRI-ESM2-0_ssp370_10m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature seasonality,T season.,year,degrees Celsius,*degree*C*, +bio05,bio05,WorldClim_2.1_MRI-ESM2-0_ssp370_10m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature of warmest month,max. T of warmest mo.,year,degrees Celsius,*degree*C*, +bio06,bio06,WorldClim_2.1_MRI-ESM2-0_ssp370_10m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature of coldest month,min. T of coldest mo.,year,degrees Celsius,*degree*C*, +bio07,bio07,WorldClim_2.1_MRI-ESM2-0_ssp370_10m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature annual range (bio05-bio06),T ann. Range,year,degrees Celsius,*degree*C*, +bio08,bio08,WorldClim_2.1_MRI-ESM2-0_ssp370_10m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of wettest quarter,mean T of wettest qtr,year,degrees Celsius,*degree*C*, +bio09,bio09,WorldClim_2.1_MRI-ESM2-0_ssp370_10m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of driest quarter,mean T of driest qtr,year,degrees Celsius,*degree*C*, +bio10,bio10,WorldClim_2.1_MRI-ESM2-0_ssp370_10m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of warmest quarter,mean T of warmest qtr,year,degrees Celsius,*degree*C*, +bio11,bio11,WorldClim_2.1_MRI-ESM2-0_ssp370_10m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of coldest quarter,mean T of coldest qtr,year,degrees Celsius,*degree*C*, +bio12,bio12,WorldClim_2.1_MRI-ESM2-0_ssp370_10m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual precipitation,ann. P,year,mm per year,*mm~yr^-1*, +bio13,bio13,WorldClim_2.1_MRI-ESM2-0_ssp370_10m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest month,P of wettest mo.,year,mm per month,*mm~mo^-1*, +bio14,bio14,WorldClim_2.1_MRI-ESM2-0_ssp370_10m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest month,P of driest mo.,year,mm per month,*mm~mo^-1*, +bio15,bio15,WorldClim_2.1_MRI-ESM2-0_ssp370_10m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation seasonality (coeff var),P season.,year,,, +bio16,bio16,WorldClim_2.1_MRI-ESM2-0_ssp370_10m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest quarter,P of wettest qtr,year,mm per quarter,*mm~qtr^-1*, +bio17,bio17,WorldClim_2.1_MRI-ESM2-0_ssp370_10m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest quarter,P of driest qtr,year,mm per quarter,*mm~qtr^-1*, +bio18,bio18,WorldClim_2.1_MRI-ESM2-0_ssp370_10m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of warmest quarter,P of warmest qtr,year,mm per quarter,*mm~qtr^-1*, +bio19,bio19,WorldClim_2.1_MRI-ESM2-0_ssp370_10m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of coldest quarter,P of coldest qtr,year,mm per quarter,*mm~qtr^-1*, +precipitation_01,precipitation_01,WorldClim_2.1_MRI-ESM2-0_ssp370_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jan,P Jan,january,mm per month,*mm~mo^-1*, +precipitation_02,precipitation_02,WorldClim_2.1_MRI-ESM2-0_ssp370_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Feb,P Feb,february,mm per month,*mm~mo^-1*, +precipitation_03,precipitation_03,WorldClim_2.1_MRI-ESM2-0_ssp370_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Mar,P Mar,march,mm per month,*mm~mo^-1*, +precipitation_04,precipitation_04,WorldClim_2.1_MRI-ESM2-0_ssp370_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Apr,P Apr,april,mm per month,*mm~mo^-1*, +precipitation_05,precipitation_05,WorldClim_2.1_MRI-ESM2-0_ssp370_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation May,P May,may,mm per month,*mm~mo^-1*, +precipitation_06,precipitation_06,WorldClim_2.1_MRI-ESM2-0_ssp370_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jun,P Jun,june,mm per month,*mm~mo^-1*, +precipitation_07,precipitation_07,WorldClim_2.1_MRI-ESM2-0_ssp370_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jul,P Jul,july,mm per month,*mm~mo^-1*, +precipitation_08,precipitation_08,WorldClim_2.1_MRI-ESM2-0_ssp370_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Aug,P Aug,august,mm per month,*mm~mo^-1*, +precipitation_09,precipitation_09,WorldClim_2.1_MRI-ESM2-0_ssp370_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Sep,P Sep,september,mm per month,*mm~mo^-1*, +precipitation_10,precipitation_10,WorldClim_2.1_MRI-ESM2-0_ssp370_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Oct,P Oct,october,mm per month,*mm~mo^-1*, +precipitation_11,precipitation_11,WorldClim_2.1_MRI-ESM2-0_ssp370_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Nov,P Nov,november,mm per month,*mm~mo^-1*, +precipitation_12,precipitation_12,WorldClim_2.1_MRI-ESM2-0_ssp370_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Dec,P Dec,december,mm per month,*mm~mo^-1*, +temperature_min_01,temperature_min_01,WorldClim_2.1_MRI-ESM2-0_ssp370_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jan,min T Jan,january,degrees Celsius,*degree*C*, +temperature_min_02,temperature_min_02,WorldClim_2.1_MRI-ESM2-0_ssp370_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Feb,min T Feb,february,degrees Celsius,*degree*C*, +temperature_min_03,temperature_min_03,WorldClim_2.1_MRI-ESM2-0_ssp370_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Mar,min T Mar,march,degrees Celsius,*degree*C*, +temperature_min_04,temperature_min_04,WorldClim_2.1_MRI-ESM2-0_ssp370_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Apr,min T Apr,april,degrees Celsius,*degree*C*, +temperature_min_05,temperature_min_05,WorldClim_2.1_MRI-ESM2-0_ssp370_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature May,min T May,may,degrees Celsius,*degree*C*, +temperature_min_06,temperature_min_06,WorldClim_2.1_MRI-ESM2-0_ssp370_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jun,min T Jun,june,degrees Celsius,*degree*C*, +temperature_min_07,temperature_min_07,WorldClim_2.1_MRI-ESM2-0_ssp370_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jul,min T Jul,july,degrees Celsius,*degree*C*, +temperature_min_08,temperature_min_08,WorldClim_2.1_MRI-ESM2-0_ssp370_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Aug,min T Aug,august,degrees Celsius,*degree*C*, +temperature_min_09,temperature_min_09,WorldClim_2.1_MRI-ESM2-0_ssp370_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Sep,min T Sep,september,degrees Celsius,*degree*C*, +temperature_min_10,temperature_min_10,WorldClim_2.1_MRI-ESM2-0_ssp370_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Oct,min T Oct,october,degrees Celsius,*degree*C*, +temperature_min_11,temperature_min_11,WorldClim_2.1_MRI-ESM2-0_ssp370_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Nov,min T Nov,november,degrees Celsius,*degree*C*, +temperature_min_12,temperature_min_12,WorldClim_2.1_MRI-ESM2-0_ssp370_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Dec,min T Dec,december,degrees Celsius,*degree*C*, +temperature_max_01,temperature_max_01,WorldClim_2.1_MRI-ESM2-0_ssp370_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jan,max T Jan,january,degrees Celsius,*degree*C*, +temperature_max_02,temperature_max_02,WorldClim_2.1_MRI-ESM2-0_ssp370_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Feb,max T Feb,february,degrees Celsius,*degree*C*, +temperature_max_03,temperature_max_03,WorldClim_2.1_MRI-ESM2-0_ssp370_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Mar,max T Mar,march,degrees Celsius,*degree*C*, +temperature_max_04,temperature_max_04,WorldClim_2.1_MRI-ESM2-0_ssp370_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Apr,max T Apr,april,degrees Celsius,*degree*C*, +temperature_max_05,temperature_max_05,WorldClim_2.1_MRI-ESM2-0_ssp370_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature May,max T May,may,degrees Celsius,*degree*C*, +temperature_max_06,temperature_max_06,WorldClim_2.1_MRI-ESM2-0_ssp370_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jun,max T Jun,june,degrees Celsius,*degree*C*, +temperature_max_07,temperature_max_07,WorldClim_2.1_MRI-ESM2-0_ssp370_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jul,max T Jul,july,degrees Celsius,*degree*C*, +temperature_max_08,temperature_max_08,WorldClim_2.1_MRI-ESM2-0_ssp370_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Aug,max T Aug,august,degrees Celsius,*degree*C*, +temperature_max_09,temperature_max_09,WorldClim_2.1_MRI-ESM2-0_ssp370_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Sep,max T Sep,september,degrees Celsius,*degree*C*, +temperature_max_10,temperature_max_10,WorldClim_2.1_MRI-ESM2-0_ssp370_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Oct,max T Oct,october,degrees Celsius,*degree*C*, +temperature_max_11,temperature_max_11,WorldClim_2.1_MRI-ESM2-0_ssp370_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Nov,max T Nov,november,degrees Celsius,*degree*C*, +temperature_max_12,temperature_max_12,WorldClim_2.1_MRI-ESM2-0_ssp370_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Dec,max T Dec,december,degrees Celsius,*degree*C*, +bio01,bio01,WorldClim_2.1_MRI-ESM2-0_ssp370_5m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual mean temperature,ann. mean T,year,degrees Celsius,*degree*C*, +bio02,bio02,WorldClim_2.1_MRI-ESM2-0_ssp370_5m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean diurnal range,diurn. range,year,degrees Celsius,*degree*C*, +bio03,bio03,WorldClim_2.1_MRI-ESM2-0_ssp370_5m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,isothermality,isothermality,year,,, +bio04,bio04,WorldClim_2.1_MRI-ESM2-0_ssp370_5m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature seasonality,T season.,year,degrees Celsius,*degree*C*, +bio05,bio05,WorldClim_2.1_MRI-ESM2-0_ssp370_5m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature of warmest month,max. T of warmest mo.,year,degrees Celsius,*degree*C*, +bio06,bio06,WorldClim_2.1_MRI-ESM2-0_ssp370_5m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature of coldest month,min. T of coldest mo.,year,degrees Celsius,*degree*C*, +bio07,bio07,WorldClim_2.1_MRI-ESM2-0_ssp370_5m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature annual range (bio05-bio06),T ann. Range,year,degrees Celsius,*degree*C*, +bio08,bio08,WorldClim_2.1_MRI-ESM2-0_ssp370_5m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of wettest quarter,mean T of wettest qtr,year,degrees Celsius,*degree*C*, +bio09,bio09,WorldClim_2.1_MRI-ESM2-0_ssp370_5m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of driest quarter,mean T of driest qtr,year,degrees Celsius,*degree*C*, +bio10,bio10,WorldClim_2.1_MRI-ESM2-0_ssp370_5m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of warmest quarter,mean T of warmest qtr,year,degrees Celsius,*degree*C*, +bio11,bio11,WorldClim_2.1_MRI-ESM2-0_ssp370_5m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of coldest quarter,mean T of coldest qtr,year,degrees Celsius,*degree*C*, +bio12,bio12,WorldClim_2.1_MRI-ESM2-0_ssp370_5m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual precipitation,ann. P,year,mm per year,*mm~yr^-1*, +bio13,bio13,WorldClim_2.1_MRI-ESM2-0_ssp370_5m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest month,P of wettest mo.,year,mm per month,*mm~mo^-1*, +bio14,bio14,WorldClim_2.1_MRI-ESM2-0_ssp370_5m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest month,P of driest mo.,year,mm per month,*mm~mo^-1*, +bio15,bio15,WorldClim_2.1_MRI-ESM2-0_ssp370_5m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation seasonality (coeff var),P season.,year,,, +bio16,bio16,WorldClim_2.1_MRI-ESM2-0_ssp370_5m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest quarter,P of wettest qtr,year,mm per quarter,*mm~qtr^-1*, +bio17,bio17,WorldClim_2.1_MRI-ESM2-0_ssp370_5m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest quarter,P of driest qtr,year,mm per quarter,*mm~qtr^-1*, +bio18,bio18,WorldClim_2.1_MRI-ESM2-0_ssp370_5m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of warmest quarter,P of warmest qtr,year,mm per quarter,*mm~qtr^-1*, +bio19,bio19,WorldClim_2.1_MRI-ESM2-0_ssp370_5m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of coldest quarter,P of coldest qtr,year,mm per quarter,*mm~qtr^-1*, +precipitation_01,precipitation_01,WorldClim_2.1_MRI-ESM2-0_ssp370_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jan,P Jan,january,mm per month,*mm~mo^-1*, +precipitation_02,precipitation_02,WorldClim_2.1_MRI-ESM2-0_ssp370_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Feb,P Feb,february,mm per month,*mm~mo^-1*, +precipitation_03,precipitation_03,WorldClim_2.1_MRI-ESM2-0_ssp370_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Mar,P Mar,march,mm per month,*mm~mo^-1*, +precipitation_04,precipitation_04,WorldClim_2.1_MRI-ESM2-0_ssp370_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Apr,P Apr,april,mm per month,*mm~mo^-1*, +precipitation_05,precipitation_05,WorldClim_2.1_MRI-ESM2-0_ssp370_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation May,P May,may,mm per month,*mm~mo^-1*, +precipitation_06,precipitation_06,WorldClim_2.1_MRI-ESM2-0_ssp370_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jun,P Jun,june,mm per month,*mm~mo^-1*, +precipitation_07,precipitation_07,WorldClim_2.1_MRI-ESM2-0_ssp370_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jul,P Jul,july,mm per month,*mm~mo^-1*, +precipitation_08,precipitation_08,WorldClim_2.1_MRI-ESM2-0_ssp370_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Aug,P Aug,august,mm per month,*mm~mo^-1*, +precipitation_09,precipitation_09,WorldClim_2.1_MRI-ESM2-0_ssp370_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Sep,P Sep,september,mm per month,*mm~mo^-1*, +precipitation_10,precipitation_10,WorldClim_2.1_MRI-ESM2-0_ssp370_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Oct,P Oct,october,mm per month,*mm~mo^-1*, +precipitation_11,precipitation_11,WorldClim_2.1_MRI-ESM2-0_ssp370_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Nov,P Nov,november,mm per month,*mm~mo^-1*, +precipitation_12,precipitation_12,WorldClim_2.1_MRI-ESM2-0_ssp370_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Dec,P Dec,december,mm per month,*mm~mo^-1*, +temperature_min_01,temperature_min_01,WorldClim_2.1_MRI-ESM2-0_ssp370_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jan,min T Jan,january,degrees Celsius,*degree*C*, +temperature_min_02,temperature_min_02,WorldClim_2.1_MRI-ESM2-0_ssp370_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Feb,min T Feb,february,degrees Celsius,*degree*C*, +temperature_min_03,temperature_min_03,WorldClim_2.1_MRI-ESM2-0_ssp370_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Mar,min T Mar,march,degrees Celsius,*degree*C*, +temperature_min_04,temperature_min_04,WorldClim_2.1_MRI-ESM2-0_ssp370_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Apr,min T Apr,april,degrees Celsius,*degree*C*, +temperature_min_05,temperature_min_05,WorldClim_2.1_MRI-ESM2-0_ssp370_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature May,min T May,may,degrees Celsius,*degree*C*, +temperature_min_06,temperature_min_06,WorldClim_2.1_MRI-ESM2-0_ssp370_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jun,min T Jun,june,degrees Celsius,*degree*C*, +temperature_min_07,temperature_min_07,WorldClim_2.1_MRI-ESM2-0_ssp370_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jul,min T Jul,july,degrees Celsius,*degree*C*, +temperature_min_08,temperature_min_08,WorldClim_2.1_MRI-ESM2-0_ssp370_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Aug,min T Aug,august,degrees Celsius,*degree*C*, +temperature_min_09,temperature_min_09,WorldClim_2.1_MRI-ESM2-0_ssp370_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Sep,min T Sep,september,degrees Celsius,*degree*C*, +temperature_min_10,temperature_min_10,WorldClim_2.1_MRI-ESM2-0_ssp370_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Oct,min T Oct,october,degrees Celsius,*degree*C*, +temperature_min_11,temperature_min_11,WorldClim_2.1_MRI-ESM2-0_ssp370_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Nov,min T Nov,november,degrees Celsius,*degree*C*, +temperature_min_12,temperature_min_12,WorldClim_2.1_MRI-ESM2-0_ssp370_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Dec,min T Dec,december,degrees Celsius,*degree*C*, +temperature_max_01,temperature_max_01,WorldClim_2.1_MRI-ESM2-0_ssp370_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jan,max T Jan,january,degrees Celsius,*degree*C*, +temperature_max_02,temperature_max_02,WorldClim_2.1_MRI-ESM2-0_ssp370_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Feb,max T Feb,february,degrees Celsius,*degree*C*, +temperature_max_03,temperature_max_03,WorldClim_2.1_MRI-ESM2-0_ssp370_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Mar,max T Mar,march,degrees Celsius,*degree*C*, +temperature_max_04,temperature_max_04,WorldClim_2.1_MRI-ESM2-0_ssp370_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Apr,max T Apr,april,degrees Celsius,*degree*C*, +temperature_max_05,temperature_max_05,WorldClim_2.1_MRI-ESM2-0_ssp370_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature May,max T May,may,degrees Celsius,*degree*C*, +temperature_max_06,temperature_max_06,WorldClim_2.1_MRI-ESM2-0_ssp370_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jun,max T Jun,june,degrees Celsius,*degree*C*, +temperature_max_07,temperature_max_07,WorldClim_2.1_MRI-ESM2-0_ssp370_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jul,max T Jul,july,degrees Celsius,*degree*C*, +temperature_max_08,temperature_max_08,WorldClim_2.1_MRI-ESM2-0_ssp370_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Aug,max T Aug,august,degrees Celsius,*degree*C*, +temperature_max_09,temperature_max_09,WorldClim_2.1_MRI-ESM2-0_ssp370_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Sep,max T Sep,september,degrees Celsius,*degree*C*, +temperature_max_10,temperature_max_10,WorldClim_2.1_MRI-ESM2-0_ssp370_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Oct,max T Oct,october,degrees Celsius,*degree*C*, +temperature_max_11,temperature_max_11,WorldClim_2.1_MRI-ESM2-0_ssp370_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Nov,max T Nov,november,degrees Celsius,*degree*C*, +temperature_max_12,temperature_max_12,WorldClim_2.1_MRI-ESM2-0_ssp370_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Dec,max T Dec,december,degrees Celsius,*degree*C*, +bio01,bio01,WorldClim_2.1_MRI-ESM2-0_ssp585_10m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual mean temperature,ann. mean T,year,degrees Celsius,*degree*C*, +bio02,bio02,WorldClim_2.1_MRI-ESM2-0_ssp585_10m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean diurnal range,diurn. range,year,degrees Celsius,*degree*C*, +bio03,bio03,WorldClim_2.1_MRI-ESM2-0_ssp585_10m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,isothermality,isothermality,year,,, +bio04,bio04,WorldClim_2.1_MRI-ESM2-0_ssp585_10m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature seasonality,T season.,year,degrees Celsius,*degree*C*, +bio05,bio05,WorldClim_2.1_MRI-ESM2-0_ssp585_10m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature of warmest month,max. T of warmest mo.,year,degrees Celsius,*degree*C*, +bio06,bio06,WorldClim_2.1_MRI-ESM2-0_ssp585_10m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature of coldest month,min. T of coldest mo.,year,degrees Celsius,*degree*C*, +bio07,bio07,WorldClim_2.1_MRI-ESM2-0_ssp585_10m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature annual range (bio05-bio06),T ann. Range,year,degrees Celsius,*degree*C*, +bio08,bio08,WorldClim_2.1_MRI-ESM2-0_ssp585_10m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of wettest quarter,mean T of wettest qtr,year,degrees Celsius,*degree*C*, +bio09,bio09,WorldClim_2.1_MRI-ESM2-0_ssp585_10m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of driest quarter,mean T of driest qtr,year,degrees Celsius,*degree*C*, +bio10,bio10,WorldClim_2.1_MRI-ESM2-0_ssp585_10m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of warmest quarter,mean T of warmest qtr,year,degrees Celsius,*degree*C*, +bio11,bio11,WorldClim_2.1_MRI-ESM2-0_ssp585_10m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of coldest quarter,mean T of coldest qtr,year,degrees Celsius,*degree*C*, +bio12,bio12,WorldClim_2.1_MRI-ESM2-0_ssp585_10m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual precipitation,ann. P,year,mm per year,*mm~yr^-1*, +bio13,bio13,WorldClim_2.1_MRI-ESM2-0_ssp585_10m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest month,P of wettest mo.,year,mm per month,*mm~mo^-1*, +bio14,bio14,WorldClim_2.1_MRI-ESM2-0_ssp585_10m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest month,P of driest mo.,year,mm per month,*mm~mo^-1*, +bio15,bio15,WorldClim_2.1_MRI-ESM2-0_ssp585_10m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation seasonality (coeff var),P season.,year,,, +bio16,bio16,WorldClim_2.1_MRI-ESM2-0_ssp585_10m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest quarter,P of wettest qtr,year,mm per quarter,*mm~qtr^-1*, +bio17,bio17,WorldClim_2.1_MRI-ESM2-0_ssp585_10m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest quarter,P of driest qtr,year,mm per quarter,*mm~qtr^-1*, +bio18,bio18,WorldClim_2.1_MRI-ESM2-0_ssp585_10m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of warmest quarter,P of warmest qtr,year,mm per quarter,*mm~qtr^-1*, +bio19,bio19,WorldClim_2.1_MRI-ESM2-0_ssp585_10m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of coldest quarter,P of coldest qtr,year,mm per quarter,*mm~qtr^-1*, +precipitation_01,precipitation_01,WorldClim_2.1_MRI-ESM2-0_ssp585_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jan,P Jan,january,mm per month,*mm~mo^-1*, +precipitation_02,precipitation_02,WorldClim_2.1_MRI-ESM2-0_ssp585_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Feb,P Feb,february,mm per month,*mm~mo^-1*, +precipitation_03,precipitation_03,WorldClim_2.1_MRI-ESM2-0_ssp585_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Mar,P Mar,march,mm per month,*mm~mo^-1*, +precipitation_04,precipitation_04,WorldClim_2.1_MRI-ESM2-0_ssp585_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Apr,P Apr,april,mm per month,*mm~mo^-1*, +precipitation_05,precipitation_05,WorldClim_2.1_MRI-ESM2-0_ssp585_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation May,P May,may,mm per month,*mm~mo^-1*, +precipitation_06,precipitation_06,WorldClim_2.1_MRI-ESM2-0_ssp585_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jun,P Jun,june,mm per month,*mm~mo^-1*, +precipitation_07,precipitation_07,WorldClim_2.1_MRI-ESM2-0_ssp585_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jul,P Jul,july,mm per month,*mm~mo^-1*, +precipitation_08,precipitation_08,WorldClim_2.1_MRI-ESM2-0_ssp585_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Aug,P Aug,august,mm per month,*mm~mo^-1*, +precipitation_09,precipitation_09,WorldClim_2.1_MRI-ESM2-0_ssp585_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Sep,P Sep,september,mm per month,*mm~mo^-1*, +precipitation_10,precipitation_10,WorldClim_2.1_MRI-ESM2-0_ssp585_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Oct,P Oct,october,mm per month,*mm~mo^-1*, +precipitation_11,precipitation_11,WorldClim_2.1_MRI-ESM2-0_ssp585_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Nov,P Nov,november,mm per month,*mm~mo^-1*, +precipitation_12,precipitation_12,WorldClim_2.1_MRI-ESM2-0_ssp585_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Dec,P Dec,december,mm per month,*mm~mo^-1*, +temperature_min_01,temperature_min_01,WorldClim_2.1_MRI-ESM2-0_ssp585_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jan,min T Jan,january,degrees Celsius,*degree*C*, +temperature_min_02,temperature_min_02,WorldClim_2.1_MRI-ESM2-0_ssp585_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Feb,min T Feb,february,degrees Celsius,*degree*C*, +temperature_min_03,temperature_min_03,WorldClim_2.1_MRI-ESM2-0_ssp585_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Mar,min T Mar,march,degrees Celsius,*degree*C*, +temperature_min_04,temperature_min_04,WorldClim_2.1_MRI-ESM2-0_ssp585_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Apr,min T Apr,april,degrees Celsius,*degree*C*, +temperature_min_05,temperature_min_05,WorldClim_2.1_MRI-ESM2-0_ssp585_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature May,min T May,may,degrees Celsius,*degree*C*, +temperature_min_06,temperature_min_06,WorldClim_2.1_MRI-ESM2-0_ssp585_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jun,min T Jun,june,degrees Celsius,*degree*C*, +temperature_min_07,temperature_min_07,WorldClim_2.1_MRI-ESM2-0_ssp585_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jul,min T Jul,july,degrees Celsius,*degree*C*, +temperature_min_08,temperature_min_08,WorldClim_2.1_MRI-ESM2-0_ssp585_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Aug,min T Aug,august,degrees Celsius,*degree*C*, +temperature_min_09,temperature_min_09,WorldClim_2.1_MRI-ESM2-0_ssp585_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Sep,min T Sep,september,degrees Celsius,*degree*C*, +temperature_min_10,temperature_min_10,WorldClim_2.1_MRI-ESM2-0_ssp585_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Oct,min T Oct,october,degrees Celsius,*degree*C*, +temperature_min_11,temperature_min_11,WorldClim_2.1_MRI-ESM2-0_ssp585_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Nov,min T Nov,november,degrees Celsius,*degree*C*, +temperature_min_12,temperature_min_12,WorldClim_2.1_MRI-ESM2-0_ssp585_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Dec,min T Dec,december,degrees Celsius,*degree*C*, +temperature_max_01,temperature_max_01,WorldClim_2.1_MRI-ESM2-0_ssp585_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jan,max T Jan,january,degrees Celsius,*degree*C*, +temperature_max_02,temperature_max_02,WorldClim_2.1_MRI-ESM2-0_ssp585_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Feb,max T Feb,february,degrees Celsius,*degree*C*, +temperature_max_03,temperature_max_03,WorldClim_2.1_MRI-ESM2-0_ssp585_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Mar,max T Mar,march,degrees Celsius,*degree*C*, +temperature_max_04,temperature_max_04,WorldClim_2.1_MRI-ESM2-0_ssp585_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Apr,max T Apr,april,degrees Celsius,*degree*C*, +temperature_max_05,temperature_max_05,WorldClim_2.1_MRI-ESM2-0_ssp585_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature May,max T May,may,degrees Celsius,*degree*C*, +temperature_max_06,temperature_max_06,WorldClim_2.1_MRI-ESM2-0_ssp585_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jun,max T Jun,june,degrees Celsius,*degree*C*, +temperature_max_07,temperature_max_07,WorldClim_2.1_MRI-ESM2-0_ssp585_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jul,max T Jul,july,degrees Celsius,*degree*C*, +temperature_max_08,temperature_max_08,WorldClim_2.1_MRI-ESM2-0_ssp585_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Aug,max T Aug,august,degrees Celsius,*degree*C*, +temperature_max_09,temperature_max_09,WorldClim_2.1_MRI-ESM2-0_ssp585_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Sep,max T Sep,september,degrees Celsius,*degree*C*, +temperature_max_10,temperature_max_10,WorldClim_2.1_MRI-ESM2-0_ssp585_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Oct,max T Oct,october,degrees Celsius,*degree*C*, +temperature_max_11,temperature_max_11,WorldClim_2.1_MRI-ESM2-0_ssp585_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Nov,max T Nov,november,degrees Celsius,*degree*C*, +temperature_max_12,temperature_max_12,WorldClim_2.1_MRI-ESM2-0_ssp585_10m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Dec,max T Dec,december,degrees Celsius,*degree*C*, +bio01,bio01,WorldClim_2.1_MRI-ESM2-0_ssp585_5m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual mean temperature,ann. mean T,year,degrees Celsius,*degree*C*, +bio02,bio02,WorldClim_2.1_MRI-ESM2-0_ssp585_5m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean diurnal range,diurn. range,year,degrees Celsius,*degree*C*, +bio03,bio03,WorldClim_2.1_MRI-ESM2-0_ssp585_5m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,isothermality,isothermality,year,,, +bio04,bio04,WorldClim_2.1_MRI-ESM2-0_ssp585_5m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature seasonality,T season.,year,degrees Celsius,*degree*C*, +bio05,bio05,WorldClim_2.1_MRI-ESM2-0_ssp585_5m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature of warmest month,max. T of warmest mo.,year,degrees Celsius,*degree*C*, +bio06,bio06,WorldClim_2.1_MRI-ESM2-0_ssp585_5m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature of coldest month,min. T of coldest mo.,year,degrees Celsius,*degree*C*, +bio07,bio07,WorldClim_2.1_MRI-ESM2-0_ssp585_5m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature annual range (bio05-bio06),T ann. Range,year,degrees Celsius,*degree*C*, +bio08,bio08,WorldClim_2.1_MRI-ESM2-0_ssp585_5m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of wettest quarter,mean T of wettest qtr,year,degrees Celsius,*degree*C*, +bio09,bio09,WorldClim_2.1_MRI-ESM2-0_ssp585_5m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of driest quarter,mean T of driest qtr,year,degrees Celsius,*degree*C*, +bio10,bio10,WorldClim_2.1_MRI-ESM2-0_ssp585_5m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of warmest quarter,mean T of warmest qtr,year,degrees Celsius,*degree*C*, +bio11,bio11,WorldClim_2.1_MRI-ESM2-0_ssp585_5m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of coldest quarter,mean T of coldest qtr,year,degrees Celsius,*degree*C*, +bio12,bio12,WorldClim_2.1_MRI-ESM2-0_ssp585_5m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual precipitation,ann. P,year,mm per year,*mm~yr^-1*, +bio13,bio13,WorldClim_2.1_MRI-ESM2-0_ssp585_5m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest month,P of wettest mo.,year,mm per month,*mm~mo^-1*, +bio14,bio14,WorldClim_2.1_MRI-ESM2-0_ssp585_5m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest month,P of driest mo.,year,mm per month,*mm~mo^-1*, +bio15,bio15,WorldClim_2.1_MRI-ESM2-0_ssp585_5m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation seasonality (coeff var),P season.,year,,, +bio16,bio16,WorldClim_2.1_MRI-ESM2-0_ssp585_5m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest quarter,P of wettest qtr,year,mm per quarter,*mm~qtr^-1*, +bio17,bio17,WorldClim_2.1_MRI-ESM2-0_ssp585_5m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest quarter,P of driest qtr,year,mm per quarter,*mm~qtr^-1*, +bio18,bio18,WorldClim_2.1_MRI-ESM2-0_ssp585_5m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of warmest quarter,P of warmest qtr,year,mm per quarter,*mm~qtr^-1*, +bio19,bio19,WorldClim_2.1_MRI-ESM2-0_ssp585_5m,FALSE,WorldClim_2.1_MRI-ESM2-0_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of coldest quarter,P of coldest qtr,year,mm per quarter,*mm~qtr^-1*, +precipitation_01,precipitation_01,WorldClim_2.1_MRI-ESM2-0_ssp585_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jan,P Jan,january,mm per month,*mm~mo^-1*, +precipitation_02,precipitation_02,WorldClim_2.1_MRI-ESM2-0_ssp585_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Feb,P Feb,february,mm per month,*mm~mo^-1*, +precipitation_03,precipitation_03,WorldClim_2.1_MRI-ESM2-0_ssp585_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Mar,P Mar,march,mm per month,*mm~mo^-1*, +precipitation_04,precipitation_04,WorldClim_2.1_MRI-ESM2-0_ssp585_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Apr,P Apr,april,mm per month,*mm~mo^-1*, +precipitation_05,precipitation_05,WorldClim_2.1_MRI-ESM2-0_ssp585_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation May,P May,may,mm per month,*mm~mo^-1*, +precipitation_06,precipitation_06,WorldClim_2.1_MRI-ESM2-0_ssp585_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jun,P Jun,june,mm per month,*mm~mo^-1*, +precipitation_07,precipitation_07,WorldClim_2.1_MRI-ESM2-0_ssp585_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jul,P Jul,july,mm per month,*mm~mo^-1*, +precipitation_08,precipitation_08,WorldClim_2.1_MRI-ESM2-0_ssp585_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Aug,P Aug,august,mm per month,*mm~mo^-1*, +precipitation_09,precipitation_09,WorldClim_2.1_MRI-ESM2-0_ssp585_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Sep,P Sep,september,mm per month,*mm~mo^-1*, +precipitation_10,precipitation_10,WorldClim_2.1_MRI-ESM2-0_ssp585_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Oct,P Oct,october,mm per month,*mm~mo^-1*, +precipitation_11,precipitation_11,WorldClim_2.1_MRI-ESM2-0_ssp585_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Nov,P Nov,november,mm per month,*mm~mo^-1*, +precipitation_12,precipitation_12,WorldClim_2.1_MRI-ESM2-0_ssp585_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Dec,P Dec,december,mm per month,*mm~mo^-1*, +temperature_min_01,temperature_min_01,WorldClim_2.1_MRI-ESM2-0_ssp585_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jan,min T Jan,january,degrees Celsius,*degree*C*, +temperature_min_02,temperature_min_02,WorldClim_2.1_MRI-ESM2-0_ssp585_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Feb,min T Feb,february,degrees Celsius,*degree*C*, +temperature_min_03,temperature_min_03,WorldClim_2.1_MRI-ESM2-0_ssp585_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Mar,min T Mar,march,degrees Celsius,*degree*C*, +temperature_min_04,temperature_min_04,WorldClim_2.1_MRI-ESM2-0_ssp585_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Apr,min T Apr,april,degrees Celsius,*degree*C*, +temperature_min_05,temperature_min_05,WorldClim_2.1_MRI-ESM2-0_ssp585_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature May,min T May,may,degrees Celsius,*degree*C*, +temperature_min_06,temperature_min_06,WorldClim_2.1_MRI-ESM2-0_ssp585_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jun,min T Jun,june,degrees Celsius,*degree*C*, +temperature_min_07,temperature_min_07,WorldClim_2.1_MRI-ESM2-0_ssp585_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jul,min T Jul,july,degrees Celsius,*degree*C*, +temperature_min_08,temperature_min_08,WorldClim_2.1_MRI-ESM2-0_ssp585_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Aug,min T Aug,august,degrees Celsius,*degree*C*, +temperature_min_09,temperature_min_09,WorldClim_2.1_MRI-ESM2-0_ssp585_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Sep,min T Sep,september,degrees Celsius,*degree*C*, +temperature_min_10,temperature_min_10,WorldClim_2.1_MRI-ESM2-0_ssp585_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Oct,min T Oct,october,degrees Celsius,*degree*C*, +temperature_min_11,temperature_min_11,WorldClim_2.1_MRI-ESM2-0_ssp585_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Nov,min T Nov,november,degrees Celsius,*degree*C*, +temperature_min_12,temperature_min_12,WorldClim_2.1_MRI-ESM2-0_ssp585_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Dec,min T Dec,december,degrees Celsius,*degree*C*, +temperature_max_01,temperature_max_01,WorldClim_2.1_MRI-ESM2-0_ssp585_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jan,max T Jan,january,degrees Celsius,*degree*C*, +temperature_max_02,temperature_max_02,WorldClim_2.1_MRI-ESM2-0_ssp585_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Feb,max T Feb,february,degrees Celsius,*degree*C*, +temperature_max_03,temperature_max_03,WorldClim_2.1_MRI-ESM2-0_ssp585_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Mar,max T Mar,march,degrees Celsius,*degree*C*, +temperature_max_04,temperature_max_04,WorldClim_2.1_MRI-ESM2-0_ssp585_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Apr,max T Apr,april,degrees Celsius,*degree*C*, +temperature_max_05,temperature_max_05,WorldClim_2.1_MRI-ESM2-0_ssp585_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature May,max T May,may,degrees Celsius,*degree*C*, +temperature_max_06,temperature_max_06,WorldClim_2.1_MRI-ESM2-0_ssp585_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jun,max T Jun,june,degrees Celsius,*degree*C*, +temperature_max_07,temperature_max_07,WorldClim_2.1_MRI-ESM2-0_ssp585_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jul,max T Jul,july,degrees Celsius,*degree*C*, +temperature_max_08,temperature_max_08,WorldClim_2.1_MRI-ESM2-0_ssp585_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Aug,max T Aug,august,degrees Celsius,*degree*C*, +temperature_max_09,temperature_max_09,WorldClim_2.1_MRI-ESM2-0_ssp585_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Sep,max T Sep,september,degrees Celsius,*degree*C*, +temperature_max_10,temperature_max_10,WorldClim_2.1_MRI-ESM2-0_ssp585_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Oct,max T Oct,october,degrees Celsius,*degree*C*, +temperature_max_11,temperature_max_11,WorldClim_2.1_MRI-ESM2-0_ssp585_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Nov,max T Nov,november,degrees Celsius,*degree*C*, +temperature_max_12,temperature_max_12,WorldClim_2.1_MRI-ESM2-0_ssp585_5m,TRUE,WorldClim_2.1_MRI-ESM2-0_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Dec,max T Dec,december,degrees Celsius,*degree*C*, +bio01,bio01,WorldClim_2.1_UKESM1-0-LL_ssp126_10m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual mean temperature,ann. mean T,year,degrees Celsius,*degree*C*, +bio02,bio02,WorldClim_2.1_UKESM1-0-LL_ssp126_10m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean diurnal range,diurn. range,year,degrees Celsius,*degree*C*, +bio03,bio03,WorldClim_2.1_UKESM1-0-LL_ssp126_10m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,isothermality,isothermality,year,,, +bio04,bio04,WorldClim_2.1_UKESM1-0-LL_ssp126_10m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature seasonality,T season.,year,degrees Celsius,*degree*C*, +bio05,bio05,WorldClim_2.1_UKESM1-0-LL_ssp126_10m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature of warmest month,max. T of warmest mo.,year,degrees Celsius,*degree*C*, +bio06,bio06,WorldClim_2.1_UKESM1-0-LL_ssp126_10m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature of coldest month,min. T of coldest mo.,year,degrees Celsius,*degree*C*, +bio07,bio07,WorldClim_2.1_UKESM1-0-LL_ssp126_10m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature annual range (bio05-bio06),T ann. Range,year,degrees Celsius,*degree*C*, +bio08,bio08,WorldClim_2.1_UKESM1-0-LL_ssp126_10m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of wettest quarter,mean T of wettest qtr,year,degrees Celsius,*degree*C*, +bio09,bio09,WorldClim_2.1_UKESM1-0-LL_ssp126_10m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of driest quarter,mean T of driest qtr,year,degrees Celsius,*degree*C*, +bio10,bio10,WorldClim_2.1_UKESM1-0-LL_ssp126_10m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of warmest quarter,mean T of warmest qtr,year,degrees Celsius,*degree*C*, +bio11,bio11,WorldClim_2.1_UKESM1-0-LL_ssp126_10m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of coldest quarter,mean T of coldest qtr,year,degrees Celsius,*degree*C*, +bio12,bio12,WorldClim_2.1_UKESM1-0-LL_ssp126_10m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual precipitation,ann. P,year,mm per year,*mm~yr^-1*, +bio13,bio13,WorldClim_2.1_UKESM1-0-LL_ssp126_10m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest month,P of wettest mo.,year,mm per month,*mm~mo^-1*, +bio14,bio14,WorldClim_2.1_UKESM1-0-LL_ssp126_10m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest month,P of driest mo.,year,mm per month,*mm~mo^-1*, +bio15,bio15,WorldClim_2.1_UKESM1-0-LL_ssp126_10m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation seasonality (coeff var),P season.,year,,, +bio16,bio16,WorldClim_2.1_UKESM1-0-LL_ssp126_10m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest quarter,P of wettest qtr,year,mm per quarter,*mm~qtr^-1*, +bio17,bio17,WorldClim_2.1_UKESM1-0-LL_ssp126_10m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest quarter,P of driest qtr,year,mm per quarter,*mm~qtr^-1*, +bio18,bio18,WorldClim_2.1_UKESM1-0-LL_ssp126_10m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of warmest quarter,P of warmest qtr,year,mm per quarter,*mm~qtr^-1*, +bio19,bio19,WorldClim_2.1_UKESM1-0-LL_ssp126_10m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp126_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of coldest quarter,P of coldest qtr,year,mm per quarter,*mm~qtr^-1*, +precipitation_01,precipitation_01,WorldClim_2.1_UKESM1-0-LL_ssp126_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jan,P Jan,january,mm per month,*mm~mo^-1*, +precipitation_02,precipitation_02,WorldClim_2.1_UKESM1-0-LL_ssp126_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Feb,P Feb,february,mm per month,*mm~mo^-1*, +precipitation_03,precipitation_03,WorldClim_2.1_UKESM1-0-LL_ssp126_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Mar,P Mar,march,mm per month,*mm~mo^-1*, +precipitation_04,precipitation_04,WorldClim_2.1_UKESM1-0-LL_ssp126_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Apr,P Apr,april,mm per month,*mm~mo^-1*, +precipitation_05,precipitation_05,WorldClim_2.1_UKESM1-0-LL_ssp126_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation May,P May,may,mm per month,*mm~mo^-1*, +precipitation_06,precipitation_06,WorldClim_2.1_UKESM1-0-LL_ssp126_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jun,P Jun,june,mm per month,*mm~mo^-1*, +precipitation_07,precipitation_07,WorldClim_2.1_UKESM1-0-LL_ssp126_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jul,P Jul,july,mm per month,*mm~mo^-1*, +precipitation_08,precipitation_08,WorldClim_2.1_UKESM1-0-LL_ssp126_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Aug,P Aug,august,mm per month,*mm~mo^-1*, +precipitation_09,precipitation_09,WorldClim_2.1_UKESM1-0-LL_ssp126_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Sep,P Sep,september,mm per month,*mm~mo^-1*, +precipitation_10,precipitation_10,WorldClim_2.1_UKESM1-0-LL_ssp126_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Oct,P Oct,october,mm per month,*mm~mo^-1*, +precipitation_11,precipitation_11,WorldClim_2.1_UKESM1-0-LL_ssp126_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Nov,P Nov,november,mm per month,*mm~mo^-1*, +precipitation_12,precipitation_12,WorldClim_2.1_UKESM1-0-LL_ssp126_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp126_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Dec,P Dec,december,mm per month,*mm~mo^-1*, +temperature_min_01,temperature_min_01,WorldClim_2.1_UKESM1-0-LL_ssp126_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jan,min T Jan,january,degrees Celsius,*degree*C*, +temperature_min_02,temperature_min_02,WorldClim_2.1_UKESM1-0-LL_ssp126_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Feb,min T Feb,february,degrees Celsius,*degree*C*, +temperature_min_03,temperature_min_03,WorldClim_2.1_UKESM1-0-LL_ssp126_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Mar,min T Mar,march,degrees Celsius,*degree*C*, +temperature_min_04,temperature_min_04,WorldClim_2.1_UKESM1-0-LL_ssp126_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Apr,min T Apr,april,degrees Celsius,*degree*C*, +temperature_min_05,temperature_min_05,WorldClim_2.1_UKESM1-0-LL_ssp126_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature May,min T May,may,degrees Celsius,*degree*C*, +temperature_min_06,temperature_min_06,WorldClim_2.1_UKESM1-0-LL_ssp126_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jun,min T Jun,june,degrees Celsius,*degree*C*, +temperature_min_07,temperature_min_07,WorldClim_2.1_UKESM1-0-LL_ssp126_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jul,min T Jul,july,degrees Celsius,*degree*C*, +temperature_min_08,temperature_min_08,WorldClim_2.1_UKESM1-0-LL_ssp126_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Aug,min T Aug,august,degrees Celsius,*degree*C*, +temperature_min_09,temperature_min_09,WorldClim_2.1_UKESM1-0-LL_ssp126_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Sep,min T Sep,september,degrees Celsius,*degree*C*, +temperature_min_10,temperature_min_10,WorldClim_2.1_UKESM1-0-LL_ssp126_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Oct,min T Oct,october,degrees Celsius,*degree*C*, +temperature_min_11,temperature_min_11,WorldClim_2.1_UKESM1-0-LL_ssp126_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Nov,min T Nov,november,degrees Celsius,*degree*C*, +temperature_min_12,temperature_min_12,WorldClim_2.1_UKESM1-0-LL_ssp126_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp126_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Dec,min T Dec,december,degrees Celsius,*degree*C*, +temperature_max_01,temperature_max_01,WorldClim_2.1_UKESM1-0-LL_ssp126_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jan,max T Jan,january,degrees Celsius,*degree*C*, +temperature_max_02,temperature_max_02,WorldClim_2.1_UKESM1-0-LL_ssp126_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Feb,max T Feb,february,degrees Celsius,*degree*C*, +temperature_max_03,temperature_max_03,WorldClim_2.1_UKESM1-0-LL_ssp126_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Mar,max T Mar,march,degrees Celsius,*degree*C*, +temperature_max_04,temperature_max_04,WorldClim_2.1_UKESM1-0-LL_ssp126_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Apr,max T Apr,april,degrees Celsius,*degree*C*, +temperature_max_05,temperature_max_05,WorldClim_2.1_UKESM1-0-LL_ssp126_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature May,max T May,may,degrees Celsius,*degree*C*, +temperature_max_06,temperature_max_06,WorldClim_2.1_UKESM1-0-LL_ssp126_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jun,max T Jun,june,degrees Celsius,*degree*C*, +temperature_max_07,temperature_max_07,WorldClim_2.1_UKESM1-0-LL_ssp126_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jul,max T Jul,july,degrees Celsius,*degree*C*, +temperature_max_08,temperature_max_08,WorldClim_2.1_UKESM1-0-LL_ssp126_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Aug,max T Aug,august,degrees Celsius,*degree*C*, +temperature_max_09,temperature_max_09,WorldClim_2.1_UKESM1-0-LL_ssp126_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Sep,max T Sep,september,degrees Celsius,*degree*C*, +temperature_max_10,temperature_max_10,WorldClim_2.1_UKESM1-0-LL_ssp126_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Oct,max T Oct,october,degrees Celsius,*degree*C*, +temperature_max_11,temperature_max_11,WorldClim_2.1_UKESM1-0-LL_ssp126_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Nov,max T Nov,november,degrees Celsius,*degree*C*, +temperature_max_12,temperature_max_12,WorldClim_2.1_UKESM1-0-LL_ssp126_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp126_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Dec,max T Dec,december,degrees Celsius,*degree*C*, +bio01,bio01,WorldClim_2.1_UKESM1-0-LL_ssp126_5m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual mean temperature,ann. mean T,year,degrees Celsius,*degree*C*, +bio02,bio02,WorldClim_2.1_UKESM1-0-LL_ssp126_5m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean diurnal range,diurn. range,year,degrees Celsius,*degree*C*, +bio03,bio03,WorldClim_2.1_UKESM1-0-LL_ssp126_5m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,isothermality,isothermality,year,,, +bio04,bio04,WorldClim_2.1_UKESM1-0-LL_ssp126_5m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature seasonality,T season.,year,degrees Celsius,*degree*C*, +bio05,bio05,WorldClim_2.1_UKESM1-0-LL_ssp126_5m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature of warmest month,max. T of warmest mo.,year,degrees Celsius,*degree*C*, +bio06,bio06,WorldClim_2.1_UKESM1-0-LL_ssp126_5m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature of coldest month,min. T of coldest mo.,year,degrees Celsius,*degree*C*, +bio07,bio07,WorldClim_2.1_UKESM1-0-LL_ssp126_5m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature annual range (bio05-bio06),T ann. Range,year,degrees Celsius,*degree*C*, +bio08,bio08,WorldClim_2.1_UKESM1-0-LL_ssp126_5m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of wettest quarter,mean T of wettest qtr,year,degrees Celsius,*degree*C*, +bio09,bio09,WorldClim_2.1_UKESM1-0-LL_ssp126_5m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of driest quarter,mean T of driest qtr,year,degrees Celsius,*degree*C*, +bio10,bio10,WorldClim_2.1_UKESM1-0-LL_ssp126_5m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of warmest quarter,mean T of warmest qtr,year,degrees Celsius,*degree*C*, +bio11,bio11,WorldClim_2.1_UKESM1-0-LL_ssp126_5m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of coldest quarter,mean T of coldest qtr,year,degrees Celsius,*degree*C*, +bio12,bio12,WorldClim_2.1_UKESM1-0-LL_ssp126_5m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual precipitation,ann. P,year,mm per year,*mm~yr^-1*, +bio13,bio13,WorldClim_2.1_UKESM1-0-LL_ssp126_5m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest month,P of wettest mo.,year,mm per month,*mm~mo^-1*, +bio14,bio14,WorldClim_2.1_UKESM1-0-LL_ssp126_5m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest month,P of driest mo.,year,mm per month,*mm~mo^-1*, +bio15,bio15,WorldClim_2.1_UKESM1-0-LL_ssp126_5m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation seasonality (coeff var),P season.,year,,, +bio16,bio16,WorldClim_2.1_UKESM1-0-LL_ssp126_5m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest quarter,P of wettest qtr,year,mm per quarter,*mm~qtr^-1*, +bio17,bio17,WorldClim_2.1_UKESM1-0-LL_ssp126_5m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest quarter,P of driest qtr,year,mm per quarter,*mm~qtr^-1*, +bio18,bio18,WorldClim_2.1_UKESM1-0-LL_ssp126_5m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of warmest quarter,P of warmest qtr,year,mm per quarter,*mm~qtr^-1*, +bio19,bio19,WorldClim_2.1_UKESM1-0-LL_ssp126_5m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp126_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of coldest quarter,P of coldest qtr,year,mm per quarter,*mm~qtr^-1*, +precipitation_01,precipitation_01,WorldClim_2.1_UKESM1-0-LL_ssp126_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jan,P Jan,january,mm per month,*mm~mo^-1*, +precipitation_02,precipitation_02,WorldClim_2.1_UKESM1-0-LL_ssp126_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Feb,P Feb,february,mm per month,*mm~mo^-1*, +precipitation_03,precipitation_03,WorldClim_2.1_UKESM1-0-LL_ssp126_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Mar,P Mar,march,mm per month,*mm~mo^-1*, +precipitation_04,precipitation_04,WorldClim_2.1_UKESM1-0-LL_ssp126_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Apr,P Apr,april,mm per month,*mm~mo^-1*, +precipitation_05,precipitation_05,WorldClim_2.1_UKESM1-0-LL_ssp126_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation May,P May,may,mm per month,*mm~mo^-1*, +precipitation_06,precipitation_06,WorldClim_2.1_UKESM1-0-LL_ssp126_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jun,P Jun,june,mm per month,*mm~mo^-1*, +precipitation_07,precipitation_07,WorldClim_2.1_UKESM1-0-LL_ssp126_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jul,P Jul,july,mm per month,*mm~mo^-1*, +precipitation_08,precipitation_08,WorldClim_2.1_UKESM1-0-LL_ssp126_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Aug,P Aug,august,mm per month,*mm~mo^-1*, +precipitation_09,precipitation_09,WorldClim_2.1_UKESM1-0-LL_ssp126_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Sep,P Sep,september,mm per month,*mm~mo^-1*, +precipitation_10,precipitation_10,WorldClim_2.1_UKESM1-0-LL_ssp126_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Oct,P Oct,october,mm per month,*mm~mo^-1*, +precipitation_11,precipitation_11,WorldClim_2.1_UKESM1-0-LL_ssp126_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Nov,P Nov,november,mm per month,*mm~mo^-1*, +precipitation_12,precipitation_12,WorldClim_2.1_UKESM1-0-LL_ssp126_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp126_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Dec,P Dec,december,mm per month,*mm~mo^-1*, +temperature_min_01,temperature_min_01,WorldClim_2.1_UKESM1-0-LL_ssp126_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jan,min T Jan,january,degrees Celsius,*degree*C*, +temperature_min_02,temperature_min_02,WorldClim_2.1_UKESM1-0-LL_ssp126_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Feb,min T Feb,february,degrees Celsius,*degree*C*, +temperature_min_03,temperature_min_03,WorldClim_2.1_UKESM1-0-LL_ssp126_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Mar,min T Mar,march,degrees Celsius,*degree*C*, +temperature_min_04,temperature_min_04,WorldClim_2.1_UKESM1-0-LL_ssp126_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Apr,min T Apr,april,degrees Celsius,*degree*C*, +temperature_min_05,temperature_min_05,WorldClim_2.1_UKESM1-0-LL_ssp126_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature May,min T May,may,degrees Celsius,*degree*C*, +temperature_min_06,temperature_min_06,WorldClim_2.1_UKESM1-0-LL_ssp126_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jun,min T Jun,june,degrees Celsius,*degree*C*, +temperature_min_07,temperature_min_07,WorldClim_2.1_UKESM1-0-LL_ssp126_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jul,min T Jul,july,degrees Celsius,*degree*C*, +temperature_min_08,temperature_min_08,WorldClim_2.1_UKESM1-0-LL_ssp126_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Aug,min T Aug,august,degrees Celsius,*degree*C*, +temperature_min_09,temperature_min_09,WorldClim_2.1_UKESM1-0-LL_ssp126_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Sep,min T Sep,september,degrees Celsius,*degree*C*, +temperature_min_10,temperature_min_10,WorldClim_2.1_UKESM1-0-LL_ssp126_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Oct,min T Oct,october,degrees Celsius,*degree*C*, +temperature_min_11,temperature_min_11,WorldClim_2.1_UKESM1-0-LL_ssp126_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Nov,min T Nov,november,degrees Celsius,*degree*C*, +temperature_min_12,temperature_min_12,WorldClim_2.1_UKESM1-0-LL_ssp126_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp126_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Dec,min T Dec,december,degrees Celsius,*degree*C*, +temperature_max_01,temperature_max_01,WorldClim_2.1_UKESM1-0-LL_ssp126_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jan,max T Jan,january,degrees Celsius,*degree*C*, +temperature_max_02,temperature_max_02,WorldClim_2.1_UKESM1-0-LL_ssp126_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Feb,max T Feb,february,degrees Celsius,*degree*C*, +temperature_max_03,temperature_max_03,WorldClim_2.1_UKESM1-0-LL_ssp126_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Mar,max T Mar,march,degrees Celsius,*degree*C*, +temperature_max_04,temperature_max_04,WorldClim_2.1_UKESM1-0-LL_ssp126_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Apr,max T Apr,april,degrees Celsius,*degree*C*, +temperature_max_05,temperature_max_05,WorldClim_2.1_UKESM1-0-LL_ssp126_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature May,max T May,may,degrees Celsius,*degree*C*, +temperature_max_06,temperature_max_06,WorldClim_2.1_UKESM1-0-LL_ssp126_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jun,max T Jun,june,degrees Celsius,*degree*C*, +temperature_max_07,temperature_max_07,WorldClim_2.1_UKESM1-0-LL_ssp126_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jul,max T Jul,july,degrees Celsius,*degree*C*, +temperature_max_08,temperature_max_08,WorldClim_2.1_UKESM1-0-LL_ssp126_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Aug,max T Aug,august,degrees Celsius,*degree*C*, +temperature_max_09,temperature_max_09,WorldClim_2.1_UKESM1-0-LL_ssp126_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Sep,max T Sep,september,degrees Celsius,*degree*C*, +temperature_max_10,temperature_max_10,WorldClim_2.1_UKESM1-0-LL_ssp126_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Oct,max T Oct,october,degrees Celsius,*degree*C*, +temperature_max_11,temperature_max_11,WorldClim_2.1_UKESM1-0-LL_ssp126_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Nov,max T Nov,november,degrees Celsius,*degree*C*, +temperature_max_12,temperature_max_12,WorldClim_2.1_UKESM1-0-LL_ssp126_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp126_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Dec,max T Dec,december,degrees Celsius,*degree*C*, +bio01,bio01,WorldClim_2.1_UKESM1-0-LL_ssp245_10m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual mean temperature,ann. mean T,year,degrees Celsius,*degree*C*, +bio02,bio02,WorldClim_2.1_UKESM1-0-LL_ssp245_10m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean diurnal range,diurn. range,year,degrees Celsius,*degree*C*, +bio03,bio03,WorldClim_2.1_UKESM1-0-LL_ssp245_10m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,isothermality,isothermality,year,,, +bio04,bio04,WorldClim_2.1_UKESM1-0-LL_ssp245_10m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature seasonality,T season.,year,degrees Celsius,*degree*C*, +bio05,bio05,WorldClim_2.1_UKESM1-0-LL_ssp245_10m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature of warmest month,max. T of warmest mo.,year,degrees Celsius,*degree*C*, +bio06,bio06,WorldClim_2.1_UKESM1-0-LL_ssp245_10m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature of coldest month,min. T of coldest mo.,year,degrees Celsius,*degree*C*, +bio07,bio07,WorldClim_2.1_UKESM1-0-LL_ssp245_10m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature annual range (bio05-bio06),T ann. Range,year,degrees Celsius,*degree*C*, +bio08,bio08,WorldClim_2.1_UKESM1-0-LL_ssp245_10m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of wettest quarter,mean T of wettest qtr,year,degrees Celsius,*degree*C*, +bio09,bio09,WorldClim_2.1_UKESM1-0-LL_ssp245_10m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of driest quarter,mean T of driest qtr,year,degrees Celsius,*degree*C*, +bio10,bio10,WorldClim_2.1_UKESM1-0-LL_ssp245_10m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of warmest quarter,mean T of warmest qtr,year,degrees Celsius,*degree*C*, +bio11,bio11,WorldClim_2.1_UKESM1-0-LL_ssp245_10m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of coldest quarter,mean T of coldest qtr,year,degrees Celsius,*degree*C*, +bio12,bio12,WorldClim_2.1_UKESM1-0-LL_ssp245_10m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual precipitation,ann. P,year,mm per year,*mm~yr^-1*, +bio13,bio13,WorldClim_2.1_UKESM1-0-LL_ssp245_10m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest month,P of wettest mo.,year,mm per month,*mm~mo^-1*, +bio14,bio14,WorldClim_2.1_UKESM1-0-LL_ssp245_10m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest month,P of driest mo.,year,mm per month,*mm~mo^-1*, +bio15,bio15,WorldClim_2.1_UKESM1-0-LL_ssp245_10m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation seasonality (coeff var),P season.,year,,, +bio16,bio16,WorldClim_2.1_UKESM1-0-LL_ssp245_10m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest quarter,P of wettest qtr,year,mm per quarter,*mm~qtr^-1*, +bio17,bio17,WorldClim_2.1_UKESM1-0-LL_ssp245_10m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest quarter,P of driest qtr,year,mm per quarter,*mm~qtr^-1*, +bio18,bio18,WorldClim_2.1_UKESM1-0-LL_ssp245_10m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of warmest quarter,P of warmest qtr,year,mm per quarter,*mm~qtr^-1*, +bio19,bio19,WorldClim_2.1_UKESM1-0-LL_ssp245_10m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp245_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of coldest quarter,P of coldest qtr,year,mm per quarter,*mm~qtr^-1*, +precipitation_01,precipitation_01,WorldClim_2.1_UKESM1-0-LL_ssp245_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jan,P Jan,january,mm per month,*mm~mo^-1*, +precipitation_02,precipitation_02,WorldClim_2.1_UKESM1-0-LL_ssp245_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Feb,P Feb,february,mm per month,*mm~mo^-1*, +precipitation_03,precipitation_03,WorldClim_2.1_UKESM1-0-LL_ssp245_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Mar,P Mar,march,mm per month,*mm~mo^-1*, +precipitation_04,precipitation_04,WorldClim_2.1_UKESM1-0-LL_ssp245_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Apr,P Apr,april,mm per month,*mm~mo^-1*, +precipitation_05,precipitation_05,WorldClim_2.1_UKESM1-0-LL_ssp245_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation May,P May,may,mm per month,*mm~mo^-1*, +precipitation_06,precipitation_06,WorldClim_2.1_UKESM1-0-LL_ssp245_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jun,P Jun,june,mm per month,*mm~mo^-1*, +precipitation_07,precipitation_07,WorldClim_2.1_UKESM1-0-LL_ssp245_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jul,P Jul,july,mm per month,*mm~mo^-1*, +precipitation_08,precipitation_08,WorldClim_2.1_UKESM1-0-LL_ssp245_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Aug,P Aug,august,mm per month,*mm~mo^-1*, +precipitation_09,precipitation_09,WorldClim_2.1_UKESM1-0-LL_ssp245_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Sep,P Sep,september,mm per month,*mm~mo^-1*, +precipitation_10,precipitation_10,WorldClim_2.1_UKESM1-0-LL_ssp245_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Oct,P Oct,october,mm per month,*mm~mo^-1*, +precipitation_11,precipitation_11,WorldClim_2.1_UKESM1-0-LL_ssp245_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Nov,P Nov,november,mm per month,*mm~mo^-1*, +precipitation_12,precipitation_12,WorldClim_2.1_UKESM1-0-LL_ssp245_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp245_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Dec,P Dec,december,mm per month,*mm~mo^-1*, +temperature_min_01,temperature_min_01,WorldClim_2.1_UKESM1-0-LL_ssp245_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jan,min T Jan,january,degrees Celsius,*degree*C*, +temperature_min_02,temperature_min_02,WorldClim_2.1_UKESM1-0-LL_ssp245_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Feb,min T Feb,february,degrees Celsius,*degree*C*, +temperature_min_03,temperature_min_03,WorldClim_2.1_UKESM1-0-LL_ssp245_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Mar,min T Mar,march,degrees Celsius,*degree*C*, +temperature_min_04,temperature_min_04,WorldClim_2.1_UKESM1-0-LL_ssp245_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Apr,min T Apr,april,degrees Celsius,*degree*C*, +temperature_min_05,temperature_min_05,WorldClim_2.1_UKESM1-0-LL_ssp245_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature May,min T May,may,degrees Celsius,*degree*C*, +temperature_min_06,temperature_min_06,WorldClim_2.1_UKESM1-0-LL_ssp245_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jun,min T Jun,june,degrees Celsius,*degree*C*, +temperature_min_07,temperature_min_07,WorldClim_2.1_UKESM1-0-LL_ssp245_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jul,min T Jul,july,degrees Celsius,*degree*C*, +temperature_min_08,temperature_min_08,WorldClim_2.1_UKESM1-0-LL_ssp245_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Aug,min T Aug,august,degrees Celsius,*degree*C*, +temperature_min_09,temperature_min_09,WorldClim_2.1_UKESM1-0-LL_ssp245_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Sep,min T Sep,september,degrees Celsius,*degree*C*, +temperature_min_10,temperature_min_10,WorldClim_2.1_UKESM1-0-LL_ssp245_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Oct,min T Oct,october,degrees Celsius,*degree*C*, +temperature_min_11,temperature_min_11,WorldClim_2.1_UKESM1-0-LL_ssp245_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Nov,min T Nov,november,degrees Celsius,*degree*C*, +temperature_min_12,temperature_min_12,WorldClim_2.1_UKESM1-0-LL_ssp245_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp245_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Dec,min T Dec,december,degrees Celsius,*degree*C*, +temperature_max_01,temperature_max_01,WorldClim_2.1_UKESM1-0-LL_ssp245_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jan,max T Jan,january,degrees Celsius,*degree*C*, +temperature_max_02,temperature_max_02,WorldClim_2.1_UKESM1-0-LL_ssp245_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Feb,max T Feb,february,degrees Celsius,*degree*C*, +temperature_max_03,temperature_max_03,WorldClim_2.1_UKESM1-0-LL_ssp245_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Mar,max T Mar,march,degrees Celsius,*degree*C*, +temperature_max_04,temperature_max_04,WorldClim_2.1_UKESM1-0-LL_ssp245_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Apr,max T Apr,april,degrees Celsius,*degree*C*, +temperature_max_05,temperature_max_05,WorldClim_2.1_UKESM1-0-LL_ssp245_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature May,max T May,may,degrees Celsius,*degree*C*, +temperature_max_06,temperature_max_06,WorldClim_2.1_UKESM1-0-LL_ssp245_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jun,max T Jun,june,degrees Celsius,*degree*C*, +temperature_max_07,temperature_max_07,WorldClim_2.1_UKESM1-0-LL_ssp245_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jul,max T Jul,july,degrees Celsius,*degree*C*, +temperature_max_08,temperature_max_08,WorldClim_2.1_UKESM1-0-LL_ssp245_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Aug,max T Aug,august,degrees Celsius,*degree*C*, +temperature_max_09,temperature_max_09,WorldClim_2.1_UKESM1-0-LL_ssp245_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Sep,max T Sep,september,degrees Celsius,*degree*C*, +temperature_max_10,temperature_max_10,WorldClim_2.1_UKESM1-0-LL_ssp245_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Oct,max T Oct,october,degrees Celsius,*degree*C*, +temperature_max_11,temperature_max_11,WorldClim_2.1_UKESM1-0-LL_ssp245_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Nov,max T Nov,november,degrees Celsius,*degree*C*, +temperature_max_12,temperature_max_12,WorldClim_2.1_UKESM1-0-LL_ssp245_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp245_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Dec,max T Dec,december,degrees Celsius,*degree*C*, +bio01,bio01,WorldClim_2.1_UKESM1-0-LL_ssp245_5m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual mean temperature,ann. mean T,year,degrees Celsius,*degree*C*, +bio02,bio02,WorldClim_2.1_UKESM1-0-LL_ssp245_5m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean diurnal range,diurn. range,year,degrees Celsius,*degree*C*, +bio03,bio03,WorldClim_2.1_UKESM1-0-LL_ssp245_5m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,isothermality,isothermality,year,,, +bio04,bio04,WorldClim_2.1_UKESM1-0-LL_ssp245_5m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature seasonality,T season.,year,degrees Celsius,*degree*C*, +bio05,bio05,WorldClim_2.1_UKESM1-0-LL_ssp245_5m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature of warmest month,max. T of warmest mo.,year,degrees Celsius,*degree*C*, +bio06,bio06,WorldClim_2.1_UKESM1-0-LL_ssp245_5m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature of coldest month,min. T of coldest mo.,year,degrees Celsius,*degree*C*, +bio07,bio07,WorldClim_2.1_UKESM1-0-LL_ssp245_5m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature annual range (bio05-bio06),T ann. Range,year,degrees Celsius,*degree*C*, +bio08,bio08,WorldClim_2.1_UKESM1-0-LL_ssp245_5m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of wettest quarter,mean T of wettest qtr,year,degrees Celsius,*degree*C*, +bio09,bio09,WorldClim_2.1_UKESM1-0-LL_ssp245_5m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of driest quarter,mean T of driest qtr,year,degrees Celsius,*degree*C*, +bio10,bio10,WorldClim_2.1_UKESM1-0-LL_ssp245_5m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of warmest quarter,mean T of warmest qtr,year,degrees Celsius,*degree*C*, +bio11,bio11,WorldClim_2.1_UKESM1-0-LL_ssp245_5m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of coldest quarter,mean T of coldest qtr,year,degrees Celsius,*degree*C*, +bio12,bio12,WorldClim_2.1_UKESM1-0-LL_ssp245_5m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual precipitation,ann. P,year,mm per year,*mm~yr^-1*, +bio13,bio13,WorldClim_2.1_UKESM1-0-LL_ssp245_5m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest month,P of wettest mo.,year,mm per month,*mm~mo^-1*, +bio14,bio14,WorldClim_2.1_UKESM1-0-LL_ssp245_5m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest month,P of driest mo.,year,mm per month,*mm~mo^-1*, +bio15,bio15,WorldClim_2.1_UKESM1-0-LL_ssp245_5m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation seasonality (coeff var),P season.,year,,, +bio16,bio16,WorldClim_2.1_UKESM1-0-LL_ssp245_5m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest quarter,P of wettest qtr,year,mm per quarter,*mm~qtr^-1*, +bio17,bio17,WorldClim_2.1_UKESM1-0-LL_ssp245_5m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest quarter,P of driest qtr,year,mm per quarter,*mm~qtr^-1*, +bio18,bio18,WorldClim_2.1_UKESM1-0-LL_ssp245_5m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of warmest quarter,P of warmest qtr,year,mm per quarter,*mm~qtr^-1*, +bio19,bio19,WorldClim_2.1_UKESM1-0-LL_ssp245_5m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp245_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of coldest quarter,P of coldest qtr,year,mm per quarter,*mm~qtr^-1*, +precipitation_01,precipitation_01,WorldClim_2.1_UKESM1-0-LL_ssp245_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jan,P Jan,january,mm per month,*mm~mo^-1*, +precipitation_02,precipitation_02,WorldClim_2.1_UKESM1-0-LL_ssp245_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Feb,P Feb,february,mm per month,*mm~mo^-1*, +precipitation_03,precipitation_03,WorldClim_2.1_UKESM1-0-LL_ssp245_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Mar,P Mar,march,mm per month,*mm~mo^-1*, +precipitation_04,precipitation_04,WorldClim_2.1_UKESM1-0-LL_ssp245_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Apr,P Apr,april,mm per month,*mm~mo^-1*, +precipitation_05,precipitation_05,WorldClim_2.1_UKESM1-0-LL_ssp245_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation May,P May,may,mm per month,*mm~mo^-1*, +precipitation_06,precipitation_06,WorldClim_2.1_UKESM1-0-LL_ssp245_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jun,P Jun,june,mm per month,*mm~mo^-1*, +precipitation_07,precipitation_07,WorldClim_2.1_UKESM1-0-LL_ssp245_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jul,P Jul,july,mm per month,*mm~mo^-1*, +precipitation_08,precipitation_08,WorldClim_2.1_UKESM1-0-LL_ssp245_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Aug,P Aug,august,mm per month,*mm~mo^-1*, +precipitation_09,precipitation_09,WorldClim_2.1_UKESM1-0-LL_ssp245_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Sep,P Sep,september,mm per month,*mm~mo^-1*, +precipitation_10,precipitation_10,WorldClim_2.1_UKESM1-0-LL_ssp245_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Oct,P Oct,october,mm per month,*mm~mo^-1*, +precipitation_11,precipitation_11,WorldClim_2.1_UKESM1-0-LL_ssp245_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Nov,P Nov,november,mm per month,*mm~mo^-1*, +precipitation_12,precipitation_12,WorldClim_2.1_UKESM1-0-LL_ssp245_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp245_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Dec,P Dec,december,mm per month,*mm~mo^-1*, +temperature_min_01,temperature_min_01,WorldClim_2.1_UKESM1-0-LL_ssp245_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jan,min T Jan,january,degrees Celsius,*degree*C*, +temperature_min_02,temperature_min_02,WorldClim_2.1_UKESM1-0-LL_ssp245_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Feb,min T Feb,february,degrees Celsius,*degree*C*, +temperature_min_03,temperature_min_03,WorldClim_2.1_UKESM1-0-LL_ssp245_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Mar,min T Mar,march,degrees Celsius,*degree*C*, +temperature_min_04,temperature_min_04,WorldClim_2.1_UKESM1-0-LL_ssp245_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Apr,min T Apr,april,degrees Celsius,*degree*C*, +temperature_min_05,temperature_min_05,WorldClim_2.1_UKESM1-0-LL_ssp245_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature May,min T May,may,degrees Celsius,*degree*C*, +temperature_min_06,temperature_min_06,WorldClim_2.1_UKESM1-0-LL_ssp245_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jun,min T Jun,june,degrees Celsius,*degree*C*, +temperature_min_07,temperature_min_07,WorldClim_2.1_UKESM1-0-LL_ssp245_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jul,min T Jul,july,degrees Celsius,*degree*C*, +temperature_min_08,temperature_min_08,WorldClim_2.1_UKESM1-0-LL_ssp245_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Aug,min T Aug,august,degrees Celsius,*degree*C*, +temperature_min_09,temperature_min_09,WorldClim_2.1_UKESM1-0-LL_ssp245_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Sep,min T Sep,september,degrees Celsius,*degree*C*, +temperature_min_10,temperature_min_10,WorldClim_2.1_UKESM1-0-LL_ssp245_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Oct,min T Oct,october,degrees Celsius,*degree*C*, +temperature_min_11,temperature_min_11,WorldClim_2.1_UKESM1-0-LL_ssp245_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Nov,min T Nov,november,degrees Celsius,*degree*C*, +temperature_min_12,temperature_min_12,WorldClim_2.1_UKESM1-0-LL_ssp245_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp245_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Dec,min T Dec,december,degrees Celsius,*degree*C*, +temperature_max_01,temperature_max_01,WorldClim_2.1_UKESM1-0-LL_ssp245_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jan,max T Jan,january,degrees Celsius,*degree*C*, +temperature_max_02,temperature_max_02,WorldClim_2.1_UKESM1-0-LL_ssp245_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Feb,max T Feb,february,degrees Celsius,*degree*C*, +temperature_max_03,temperature_max_03,WorldClim_2.1_UKESM1-0-LL_ssp245_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Mar,max T Mar,march,degrees Celsius,*degree*C*, +temperature_max_04,temperature_max_04,WorldClim_2.1_UKESM1-0-LL_ssp245_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Apr,max T Apr,april,degrees Celsius,*degree*C*, +temperature_max_05,temperature_max_05,WorldClim_2.1_UKESM1-0-LL_ssp245_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature May,max T May,may,degrees Celsius,*degree*C*, +temperature_max_06,temperature_max_06,WorldClim_2.1_UKESM1-0-LL_ssp245_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jun,max T Jun,june,degrees Celsius,*degree*C*, +temperature_max_07,temperature_max_07,WorldClim_2.1_UKESM1-0-LL_ssp245_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jul,max T Jul,july,degrees Celsius,*degree*C*, +temperature_max_08,temperature_max_08,WorldClim_2.1_UKESM1-0-LL_ssp245_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Aug,max T Aug,august,degrees Celsius,*degree*C*, +temperature_max_09,temperature_max_09,WorldClim_2.1_UKESM1-0-LL_ssp245_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Sep,max T Sep,september,degrees Celsius,*degree*C*, +temperature_max_10,temperature_max_10,WorldClim_2.1_UKESM1-0-LL_ssp245_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Oct,max T Oct,october,degrees Celsius,*degree*C*, +temperature_max_11,temperature_max_11,WorldClim_2.1_UKESM1-0-LL_ssp245_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Nov,max T Nov,november,degrees Celsius,*degree*C*, +temperature_max_12,temperature_max_12,WorldClim_2.1_UKESM1-0-LL_ssp245_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp245_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Dec,max T Dec,december,degrees Celsius,*degree*C*, +bio01,bio01,WorldClim_2.1_UKESM1-0-LL_ssp370_10m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual mean temperature,ann. mean T,year,degrees Celsius,*degree*C*, +bio02,bio02,WorldClim_2.1_UKESM1-0-LL_ssp370_10m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean diurnal range,diurn. range,year,degrees Celsius,*degree*C*, +bio03,bio03,WorldClim_2.1_UKESM1-0-LL_ssp370_10m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,isothermality,isothermality,year,,, +bio04,bio04,WorldClim_2.1_UKESM1-0-LL_ssp370_10m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature seasonality,T season.,year,degrees Celsius,*degree*C*, +bio05,bio05,WorldClim_2.1_UKESM1-0-LL_ssp370_10m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature of warmest month,max. T of warmest mo.,year,degrees Celsius,*degree*C*, +bio06,bio06,WorldClim_2.1_UKESM1-0-LL_ssp370_10m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature of coldest month,min. T of coldest mo.,year,degrees Celsius,*degree*C*, +bio07,bio07,WorldClim_2.1_UKESM1-0-LL_ssp370_10m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature annual range (bio05-bio06),T ann. Range,year,degrees Celsius,*degree*C*, +bio08,bio08,WorldClim_2.1_UKESM1-0-LL_ssp370_10m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of wettest quarter,mean T of wettest qtr,year,degrees Celsius,*degree*C*, +bio09,bio09,WorldClim_2.1_UKESM1-0-LL_ssp370_10m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of driest quarter,mean T of driest qtr,year,degrees Celsius,*degree*C*, +bio10,bio10,WorldClim_2.1_UKESM1-0-LL_ssp370_10m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of warmest quarter,mean T of warmest qtr,year,degrees Celsius,*degree*C*, +bio11,bio11,WorldClim_2.1_UKESM1-0-LL_ssp370_10m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of coldest quarter,mean T of coldest qtr,year,degrees Celsius,*degree*C*, +bio12,bio12,WorldClim_2.1_UKESM1-0-LL_ssp370_10m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual precipitation,ann. P,year,mm per year,*mm~yr^-1*, +bio13,bio13,WorldClim_2.1_UKESM1-0-LL_ssp370_10m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest month,P of wettest mo.,year,mm per month,*mm~mo^-1*, +bio14,bio14,WorldClim_2.1_UKESM1-0-LL_ssp370_10m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest month,P of driest mo.,year,mm per month,*mm~mo^-1*, +bio15,bio15,WorldClim_2.1_UKESM1-0-LL_ssp370_10m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation seasonality (coeff var),P season.,year,,, +bio16,bio16,WorldClim_2.1_UKESM1-0-LL_ssp370_10m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest quarter,P of wettest qtr,year,mm per quarter,*mm~qtr^-1*, +bio17,bio17,WorldClim_2.1_UKESM1-0-LL_ssp370_10m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest quarter,P of driest qtr,year,mm per quarter,*mm~qtr^-1*, +bio18,bio18,WorldClim_2.1_UKESM1-0-LL_ssp370_10m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of warmest quarter,P of warmest qtr,year,mm per quarter,*mm~qtr^-1*, +bio19,bio19,WorldClim_2.1_UKESM1-0-LL_ssp370_10m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp370_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of coldest quarter,P of coldest qtr,year,mm per quarter,*mm~qtr^-1*, +precipitation_01,precipitation_01,WorldClim_2.1_UKESM1-0-LL_ssp370_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jan,P Jan,january,mm per month,*mm~mo^-1*, +precipitation_02,precipitation_02,WorldClim_2.1_UKESM1-0-LL_ssp370_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Feb,P Feb,february,mm per month,*mm~mo^-1*, +precipitation_03,precipitation_03,WorldClim_2.1_UKESM1-0-LL_ssp370_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Mar,P Mar,march,mm per month,*mm~mo^-1*, +precipitation_04,precipitation_04,WorldClim_2.1_UKESM1-0-LL_ssp370_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Apr,P Apr,april,mm per month,*mm~mo^-1*, +precipitation_05,precipitation_05,WorldClim_2.1_UKESM1-0-LL_ssp370_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation May,P May,may,mm per month,*mm~mo^-1*, +precipitation_06,precipitation_06,WorldClim_2.1_UKESM1-0-LL_ssp370_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jun,P Jun,june,mm per month,*mm~mo^-1*, +precipitation_07,precipitation_07,WorldClim_2.1_UKESM1-0-LL_ssp370_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jul,P Jul,july,mm per month,*mm~mo^-1*, +precipitation_08,precipitation_08,WorldClim_2.1_UKESM1-0-LL_ssp370_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Aug,P Aug,august,mm per month,*mm~mo^-1*, +precipitation_09,precipitation_09,WorldClim_2.1_UKESM1-0-LL_ssp370_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Sep,P Sep,september,mm per month,*mm~mo^-1*, +precipitation_10,precipitation_10,WorldClim_2.1_UKESM1-0-LL_ssp370_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Oct,P Oct,october,mm per month,*mm~mo^-1*, +precipitation_11,precipitation_11,WorldClim_2.1_UKESM1-0-LL_ssp370_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Nov,P Nov,november,mm per month,*mm~mo^-1*, +precipitation_12,precipitation_12,WorldClim_2.1_UKESM1-0-LL_ssp370_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp370_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Dec,P Dec,december,mm per month,*mm~mo^-1*, +temperature_min_01,temperature_min_01,WorldClim_2.1_UKESM1-0-LL_ssp370_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jan,min T Jan,january,degrees Celsius,*degree*C*, +temperature_min_02,temperature_min_02,WorldClim_2.1_UKESM1-0-LL_ssp370_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Feb,min T Feb,february,degrees Celsius,*degree*C*, +temperature_min_03,temperature_min_03,WorldClim_2.1_UKESM1-0-LL_ssp370_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Mar,min T Mar,march,degrees Celsius,*degree*C*, +temperature_min_04,temperature_min_04,WorldClim_2.1_UKESM1-0-LL_ssp370_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Apr,min T Apr,april,degrees Celsius,*degree*C*, +temperature_min_05,temperature_min_05,WorldClim_2.1_UKESM1-0-LL_ssp370_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature May,min T May,may,degrees Celsius,*degree*C*, +temperature_min_06,temperature_min_06,WorldClim_2.1_UKESM1-0-LL_ssp370_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jun,min T Jun,june,degrees Celsius,*degree*C*, +temperature_min_07,temperature_min_07,WorldClim_2.1_UKESM1-0-LL_ssp370_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jul,min T Jul,july,degrees Celsius,*degree*C*, +temperature_min_08,temperature_min_08,WorldClim_2.1_UKESM1-0-LL_ssp370_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Aug,min T Aug,august,degrees Celsius,*degree*C*, +temperature_min_09,temperature_min_09,WorldClim_2.1_UKESM1-0-LL_ssp370_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Sep,min T Sep,september,degrees Celsius,*degree*C*, +temperature_min_10,temperature_min_10,WorldClim_2.1_UKESM1-0-LL_ssp370_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Oct,min T Oct,october,degrees Celsius,*degree*C*, +temperature_min_11,temperature_min_11,WorldClim_2.1_UKESM1-0-LL_ssp370_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Nov,min T Nov,november,degrees Celsius,*degree*C*, +temperature_min_12,temperature_min_12,WorldClim_2.1_UKESM1-0-LL_ssp370_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp370_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Dec,min T Dec,december,degrees Celsius,*degree*C*, +temperature_max_01,temperature_max_01,WorldClim_2.1_UKESM1-0-LL_ssp370_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jan,max T Jan,january,degrees Celsius,*degree*C*, +temperature_max_02,temperature_max_02,WorldClim_2.1_UKESM1-0-LL_ssp370_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Feb,max T Feb,february,degrees Celsius,*degree*C*, +temperature_max_03,temperature_max_03,WorldClim_2.1_UKESM1-0-LL_ssp370_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Mar,max T Mar,march,degrees Celsius,*degree*C*, +temperature_max_04,temperature_max_04,WorldClim_2.1_UKESM1-0-LL_ssp370_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Apr,max T Apr,april,degrees Celsius,*degree*C*, +temperature_max_05,temperature_max_05,WorldClim_2.1_UKESM1-0-LL_ssp370_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature May,max T May,may,degrees Celsius,*degree*C*, +temperature_max_06,temperature_max_06,WorldClim_2.1_UKESM1-0-LL_ssp370_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jun,max T Jun,june,degrees Celsius,*degree*C*, +temperature_max_07,temperature_max_07,WorldClim_2.1_UKESM1-0-LL_ssp370_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jul,max T Jul,july,degrees Celsius,*degree*C*, +temperature_max_08,temperature_max_08,WorldClim_2.1_UKESM1-0-LL_ssp370_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Aug,max T Aug,august,degrees Celsius,*degree*C*, +temperature_max_09,temperature_max_09,WorldClim_2.1_UKESM1-0-LL_ssp370_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Sep,max T Sep,september,degrees Celsius,*degree*C*, +temperature_max_10,temperature_max_10,WorldClim_2.1_UKESM1-0-LL_ssp370_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Oct,max T Oct,october,degrees Celsius,*degree*C*, +temperature_max_11,temperature_max_11,WorldClim_2.1_UKESM1-0-LL_ssp370_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Nov,max T Nov,november,degrees Celsius,*degree*C*, +temperature_max_12,temperature_max_12,WorldClim_2.1_UKESM1-0-LL_ssp370_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp370_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Dec,max T Dec,december,degrees Celsius,*degree*C*, +bio01,bio01,WorldClim_2.1_UKESM1-0-LL_ssp370_5m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual mean temperature,ann. mean T,year,degrees Celsius,*degree*C*, +bio02,bio02,WorldClim_2.1_UKESM1-0-LL_ssp370_5m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean diurnal range,diurn. range,year,degrees Celsius,*degree*C*, +bio03,bio03,WorldClim_2.1_UKESM1-0-LL_ssp370_5m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,isothermality,isothermality,year,,, +bio04,bio04,WorldClim_2.1_UKESM1-0-LL_ssp370_5m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature seasonality,T season.,year,degrees Celsius,*degree*C*, +bio05,bio05,WorldClim_2.1_UKESM1-0-LL_ssp370_5m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature of warmest month,max. T of warmest mo.,year,degrees Celsius,*degree*C*, +bio06,bio06,WorldClim_2.1_UKESM1-0-LL_ssp370_5m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature of coldest month,min. T of coldest mo.,year,degrees Celsius,*degree*C*, +bio07,bio07,WorldClim_2.1_UKESM1-0-LL_ssp370_5m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature annual range (bio05-bio06),T ann. Range,year,degrees Celsius,*degree*C*, +bio08,bio08,WorldClim_2.1_UKESM1-0-LL_ssp370_5m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of wettest quarter,mean T of wettest qtr,year,degrees Celsius,*degree*C*, +bio09,bio09,WorldClim_2.1_UKESM1-0-LL_ssp370_5m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of driest quarter,mean T of driest qtr,year,degrees Celsius,*degree*C*, +bio10,bio10,WorldClim_2.1_UKESM1-0-LL_ssp370_5m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of warmest quarter,mean T of warmest qtr,year,degrees Celsius,*degree*C*, +bio11,bio11,WorldClim_2.1_UKESM1-0-LL_ssp370_5m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of coldest quarter,mean T of coldest qtr,year,degrees Celsius,*degree*C*, +bio12,bio12,WorldClim_2.1_UKESM1-0-LL_ssp370_5m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual precipitation,ann. P,year,mm per year,*mm~yr^-1*, +bio13,bio13,WorldClim_2.1_UKESM1-0-LL_ssp370_5m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest month,P of wettest mo.,year,mm per month,*mm~mo^-1*, +bio14,bio14,WorldClim_2.1_UKESM1-0-LL_ssp370_5m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest month,P of driest mo.,year,mm per month,*mm~mo^-1*, +bio15,bio15,WorldClim_2.1_UKESM1-0-LL_ssp370_5m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation seasonality (coeff var),P season.,year,,, +bio16,bio16,WorldClim_2.1_UKESM1-0-LL_ssp370_5m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest quarter,P of wettest qtr,year,mm per quarter,*mm~qtr^-1*, +bio17,bio17,WorldClim_2.1_UKESM1-0-LL_ssp370_5m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest quarter,P of driest qtr,year,mm per quarter,*mm~qtr^-1*, +bio18,bio18,WorldClim_2.1_UKESM1-0-LL_ssp370_5m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of warmest quarter,P of warmest qtr,year,mm per quarter,*mm~qtr^-1*, +bio19,bio19,WorldClim_2.1_UKESM1-0-LL_ssp370_5m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp370_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of coldest quarter,P of coldest qtr,year,mm per quarter,*mm~qtr^-1*, +precipitation_01,precipitation_01,WorldClim_2.1_UKESM1-0-LL_ssp370_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jan,P Jan,january,mm per month,*mm~mo^-1*, +precipitation_02,precipitation_02,WorldClim_2.1_UKESM1-0-LL_ssp370_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Feb,P Feb,february,mm per month,*mm~mo^-1*, +precipitation_03,precipitation_03,WorldClim_2.1_UKESM1-0-LL_ssp370_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Mar,P Mar,march,mm per month,*mm~mo^-1*, +precipitation_04,precipitation_04,WorldClim_2.1_UKESM1-0-LL_ssp370_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Apr,P Apr,april,mm per month,*mm~mo^-1*, +precipitation_05,precipitation_05,WorldClim_2.1_UKESM1-0-LL_ssp370_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation May,P May,may,mm per month,*mm~mo^-1*, +precipitation_06,precipitation_06,WorldClim_2.1_UKESM1-0-LL_ssp370_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jun,P Jun,june,mm per month,*mm~mo^-1*, +precipitation_07,precipitation_07,WorldClim_2.1_UKESM1-0-LL_ssp370_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jul,P Jul,july,mm per month,*mm~mo^-1*, +precipitation_08,precipitation_08,WorldClim_2.1_UKESM1-0-LL_ssp370_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Aug,P Aug,august,mm per month,*mm~mo^-1*, +precipitation_09,precipitation_09,WorldClim_2.1_UKESM1-0-LL_ssp370_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Sep,P Sep,september,mm per month,*mm~mo^-1*, +precipitation_10,precipitation_10,WorldClim_2.1_UKESM1-0-LL_ssp370_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Oct,P Oct,october,mm per month,*mm~mo^-1*, +precipitation_11,precipitation_11,WorldClim_2.1_UKESM1-0-LL_ssp370_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Nov,P Nov,november,mm per month,*mm~mo^-1*, +precipitation_12,precipitation_12,WorldClim_2.1_UKESM1-0-LL_ssp370_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp370_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Dec,P Dec,december,mm per month,*mm~mo^-1*, +temperature_min_01,temperature_min_01,WorldClim_2.1_UKESM1-0-LL_ssp370_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jan,min T Jan,january,degrees Celsius,*degree*C*, +temperature_min_02,temperature_min_02,WorldClim_2.1_UKESM1-0-LL_ssp370_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Feb,min T Feb,february,degrees Celsius,*degree*C*, +temperature_min_03,temperature_min_03,WorldClim_2.1_UKESM1-0-LL_ssp370_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Mar,min T Mar,march,degrees Celsius,*degree*C*, +temperature_min_04,temperature_min_04,WorldClim_2.1_UKESM1-0-LL_ssp370_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Apr,min T Apr,april,degrees Celsius,*degree*C*, +temperature_min_05,temperature_min_05,WorldClim_2.1_UKESM1-0-LL_ssp370_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature May,min T May,may,degrees Celsius,*degree*C*, +temperature_min_06,temperature_min_06,WorldClim_2.1_UKESM1-0-LL_ssp370_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jun,min T Jun,june,degrees Celsius,*degree*C*, +temperature_min_07,temperature_min_07,WorldClim_2.1_UKESM1-0-LL_ssp370_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jul,min T Jul,july,degrees Celsius,*degree*C*, +temperature_min_08,temperature_min_08,WorldClim_2.1_UKESM1-0-LL_ssp370_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Aug,min T Aug,august,degrees Celsius,*degree*C*, +temperature_min_09,temperature_min_09,WorldClim_2.1_UKESM1-0-LL_ssp370_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Sep,min T Sep,september,degrees Celsius,*degree*C*, +temperature_min_10,temperature_min_10,WorldClim_2.1_UKESM1-0-LL_ssp370_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Oct,min T Oct,october,degrees Celsius,*degree*C*, +temperature_min_11,temperature_min_11,WorldClim_2.1_UKESM1-0-LL_ssp370_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Nov,min T Nov,november,degrees Celsius,*degree*C*, +temperature_min_12,temperature_min_12,WorldClim_2.1_UKESM1-0-LL_ssp370_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp370_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Dec,min T Dec,december,degrees Celsius,*degree*C*, +temperature_max_01,temperature_max_01,WorldClim_2.1_UKESM1-0-LL_ssp370_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jan,max T Jan,january,degrees Celsius,*degree*C*, +temperature_max_02,temperature_max_02,WorldClim_2.1_UKESM1-0-LL_ssp370_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Feb,max T Feb,february,degrees Celsius,*degree*C*, +temperature_max_03,temperature_max_03,WorldClim_2.1_UKESM1-0-LL_ssp370_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Mar,max T Mar,march,degrees Celsius,*degree*C*, +temperature_max_04,temperature_max_04,WorldClim_2.1_UKESM1-0-LL_ssp370_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Apr,max T Apr,april,degrees Celsius,*degree*C*, +temperature_max_05,temperature_max_05,WorldClim_2.1_UKESM1-0-LL_ssp370_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature May,max T May,may,degrees Celsius,*degree*C*, +temperature_max_06,temperature_max_06,WorldClim_2.1_UKESM1-0-LL_ssp370_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jun,max T Jun,june,degrees Celsius,*degree*C*, +temperature_max_07,temperature_max_07,WorldClim_2.1_UKESM1-0-LL_ssp370_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jul,max T Jul,july,degrees Celsius,*degree*C*, +temperature_max_08,temperature_max_08,WorldClim_2.1_UKESM1-0-LL_ssp370_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Aug,max T Aug,august,degrees Celsius,*degree*C*, +temperature_max_09,temperature_max_09,WorldClim_2.1_UKESM1-0-LL_ssp370_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Sep,max T Sep,september,degrees Celsius,*degree*C*, +temperature_max_10,temperature_max_10,WorldClim_2.1_UKESM1-0-LL_ssp370_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Oct,max T Oct,october,degrees Celsius,*degree*C*, +temperature_max_11,temperature_max_11,WorldClim_2.1_UKESM1-0-LL_ssp370_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Nov,max T Nov,november,degrees Celsius,*degree*C*, +temperature_max_12,temperature_max_12,WorldClim_2.1_UKESM1-0-LL_ssp370_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp370_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Dec,max T Dec,december,degrees Celsius,*degree*C*, +bio01,bio01,WorldClim_2.1_UKESM1-0-LL_ssp585_10m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual mean temperature,ann. mean T,year,degrees Celsius,*degree*C*, +bio02,bio02,WorldClim_2.1_UKESM1-0-LL_ssp585_10m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean diurnal range,diurn. range,year,degrees Celsius,*degree*C*, +bio03,bio03,WorldClim_2.1_UKESM1-0-LL_ssp585_10m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,isothermality,isothermality,year,,, +bio04,bio04,WorldClim_2.1_UKESM1-0-LL_ssp585_10m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature seasonality,T season.,year,degrees Celsius,*degree*C*, +bio05,bio05,WorldClim_2.1_UKESM1-0-LL_ssp585_10m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature of warmest month,max. T of warmest mo.,year,degrees Celsius,*degree*C*, +bio06,bio06,WorldClim_2.1_UKESM1-0-LL_ssp585_10m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature of coldest month,min. T of coldest mo.,year,degrees Celsius,*degree*C*, +bio07,bio07,WorldClim_2.1_UKESM1-0-LL_ssp585_10m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature annual range (bio05-bio06),T ann. Range,year,degrees Celsius,*degree*C*, +bio08,bio08,WorldClim_2.1_UKESM1-0-LL_ssp585_10m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of wettest quarter,mean T of wettest qtr,year,degrees Celsius,*degree*C*, +bio09,bio09,WorldClim_2.1_UKESM1-0-LL_ssp585_10m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of driest quarter,mean T of driest qtr,year,degrees Celsius,*degree*C*, +bio10,bio10,WorldClim_2.1_UKESM1-0-LL_ssp585_10m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of warmest quarter,mean T of warmest qtr,year,degrees Celsius,*degree*C*, +bio11,bio11,WorldClim_2.1_UKESM1-0-LL_ssp585_10m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of coldest quarter,mean T of coldest qtr,year,degrees Celsius,*degree*C*, +bio12,bio12,WorldClim_2.1_UKESM1-0-LL_ssp585_10m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual precipitation,ann. P,year,mm per year,*mm~yr^-1*, +bio13,bio13,WorldClim_2.1_UKESM1-0-LL_ssp585_10m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest month,P of wettest mo.,year,mm per month,*mm~mo^-1*, +bio14,bio14,WorldClim_2.1_UKESM1-0-LL_ssp585_10m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest month,P of driest mo.,year,mm per month,*mm~mo^-1*, +bio15,bio15,WorldClim_2.1_UKESM1-0-LL_ssp585_10m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation seasonality (coeff var),P season.,year,,, +bio16,bio16,WorldClim_2.1_UKESM1-0-LL_ssp585_10m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest quarter,P of wettest qtr,year,mm per quarter,*mm~qtr^-1*, +bio17,bio17,WorldClim_2.1_UKESM1-0-LL_ssp585_10m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest quarter,P of driest qtr,year,mm per quarter,*mm~qtr^-1*, +bio18,bio18,WorldClim_2.1_UKESM1-0-LL_ssp585_10m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of warmest quarter,P of warmest qtr,year,mm per quarter,*mm~qtr^-1*, +bio19,bio19,WorldClim_2.1_UKESM1-0-LL_ssp585_10m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp585_10m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of coldest quarter,P of coldest qtr,year,mm per quarter,*mm~qtr^-1*, +precipitation_01,precipitation_01,WorldClim_2.1_UKESM1-0-LL_ssp585_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jan,P Jan,january,mm per month,*mm~mo^-1*, +precipitation_02,precipitation_02,WorldClim_2.1_UKESM1-0-LL_ssp585_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Feb,P Feb,february,mm per month,*mm~mo^-1*, +precipitation_03,precipitation_03,WorldClim_2.1_UKESM1-0-LL_ssp585_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Mar,P Mar,march,mm per month,*mm~mo^-1*, +precipitation_04,precipitation_04,WorldClim_2.1_UKESM1-0-LL_ssp585_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Apr,P Apr,april,mm per month,*mm~mo^-1*, +precipitation_05,precipitation_05,WorldClim_2.1_UKESM1-0-LL_ssp585_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation May,P May,may,mm per month,*mm~mo^-1*, +precipitation_06,precipitation_06,WorldClim_2.1_UKESM1-0-LL_ssp585_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jun,P Jun,june,mm per month,*mm~mo^-1*, +precipitation_07,precipitation_07,WorldClim_2.1_UKESM1-0-LL_ssp585_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jul,P Jul,july,mm per month,*mm~mo^-1*, +precipitation_08,precipitation_08,WorldClim_2.1_UKESM1-0-LL_ssp585_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Aug,P Aug,august,mm per month,*mm~mo^-1*, +precipitation_09,precipitation_09,WorldClim_2.1_UKESM1-0-LL_ssp585_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Sep,P Sep,september,mm per month,*mm~mo^-1*, +precipitation_10,precipitation_10,WorldClim_2.1_UKESM1-0-LL_ssp585_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Oct,P Oct,october,mm per month,*mm~mo^-1*, +precipitation_11,precipitation_11,WorldClim_2.1_UKESM1-0-LL_ssp585_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Nov,P Nov,november,mm per month,*mm~mo^-1*, +precipitation_12,precipitation_12,WorldClim_2.1_UKESM1-0-LL_ssp585_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp585_10m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Dec,P Dec,december,mm per month,*mm~mo^-1*, +temperature_min_01,temperature_min_01,WorldClim_2.1_UKESM1-0-LL_ssp585_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jan,min T Jan,january,degrees Celsius,*degree*C*, +temperature_min_02,temperature_min_02,WorldClim_2.1_UKESM1-0-LL_ssp585_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Feb,min T Feb,february,degrees Celsius,*degree*C*, +temperature_min_03,temperature_min_03,WorldClim_2.1_UKESM1-0-LL_ssp585_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Mar,min T Mar,march,degrees Celsius,*degree*C*, +temperature_min_04,temperature_min_04,WorldClim_2.1_UKESM1-0-LL_ssp585_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Apr,min T Apr,april,degrees Celsius,*degree*C*, +temperature_min_05,temperature_min_05,WorldClim_2.1_UKESM1-0-LL_ssp585_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature May,min T May,may,degrees Celsius,*degree*C*, +temperature_min_06,temperature_min_06,WorldClim_2.1_UKESM1-0-LL_ssp585_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jun,min T Jun,june,degrees Celsius,*degree*C*, +temperature_min_07,temperature_min_07,WorldClim_2.1_UKESM1-0-LL_ssp585_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jul,min T Jul,july,degrees Celsius,*degree*C*, +temperature_min_08,temperature_min_08,WorldClim_2.1_UKESM1-0-LL_ssp585_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Aug,min T Aug,august,degrees Celsius,*degree*C*, +temperature_min_09,temperature_min_09,WorldClim_2.1_UKESM1-0-LL_ssp585_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Sep,min T Sep,september,degrees Celsius,*degree*C*, +temperature_min_10,temperature_min_10,WorldClim_2.1_UKESM1-0-LL_ssp585_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Oct,min T Oct,october,degrees Celsius,*degree*C*, +temperature_min_11,temperature_min_11,WorldClim_2.1_UKESM1-0-LL_ssp585_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Nov,min T Nov,november,degrees Celsius,*degree*C*, +temperature_min_12,temperature_min_12,WorldClim_2.1_UKESM1-0-LL_ssp585_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp585_10m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Dec,min T Dec,december,degrees Celsius,*degree*C*, +temperature_max_01,temperature_max_01,WorldClim_2.1_UKESM1-0-LL_ssp585_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jan,max T Jan,january,degrees Celsius,*degree*C*, +temperature_max_02,temperature_max_02,WorldClim_2.1_UKESM1-0-LL_ssp585_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Feb,max T Feb,february,degrees Celsius,*degree*C*, +temperature_max_03,temperature_max_03,WorldClim_2.1_UKESM1-0-LL_ssp585_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Mar,max T Mar,march,degrees Celsius,*degree*C*, +temperature_max_04,temperature_max_04,WorldClim_2.1_UKESM1-0-LL_ssp585_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Apr,max T Apr,april,degrees Celsius,*degree*C*, +temperature_max_05,temperature_max_05,WorldClim_2.1_UKESM1-0-LL_ssp585_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature May,max T May,may,degrees Celsius,*degree*C*, +temperature_max_06,temperature_max_06,WorldClim_2.1_UKESM1-0-LL_ssp585_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jun,max T Jun,june,degrees Celsius,*degree*C*, +temperature_max_07,temperature_max_07,WorldClim_2.1_UKESM1-0-LL_ssp585_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jul,max T Jul,july,degrees Celsius,*degree*C*, +temperature_max_08,temperature_max_08,WorldClim_2.1_UKESM1-0-LL_ssp585_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Aug,max T Aug,august,degrees Celsius,*degree*C*, +temperature_max_09,temperature_max_09,WorldClim_2.1_UKESM1-0-LL_ssp585_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Sep,max T Sep,september,degrees Celsius,*degree*C*, +temperature_max_10,temperature_max_10,WorldClim_2.1_UKESM1-0-LL_ssp585_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Oct,max T Oct,october,degrees Celsius,*degree*C*, +temperature_max_11,temperature_max_11,WorldClim_2.1_UKESM1-0-LL_ssp585_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Nov,max T Nov,november,degrees Celsius,*degree*C*, +temperature_max_12,temperature_max_12,WorldClim_2.1_UKESM1-0-LL_ssp585_10m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp585_10m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Dec,max T Dec,december,degrees Celsius,*degree*C*, +bio01,bio01,WorldClim_2.1_UKESM1-0-LL_ssp585_5m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual mean temperature,ann. mean T,year,degrees Celsius,*degree*C*, +bio02,bio02,WorldClim_2.1_UKESM1-0-LL_ssp585_5m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean diurnal range,diurn. range,year,degrees Celsius,*degree*C*, +bio03,bio03,WorldClim_2.1_UKESM1-0-LL_ssp585_5m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,isothermality,isothermality,year,,, +bio04,bio04,WorldClim_2.1_UKESM1-0-LL_ssp585_5m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature seasonality,T season.,year,degrees Celsius,*degree*C*, +bio05,bio05,WorldClim_2.1_UKESM1-0-LL_ssp585_5m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature of warmest month,max. T of warmest mo.,year,degrees Celsius,*degree*C*, +bio06,bio06,WorldClim_2.1_UKESM1-0-LL_ssp585_5m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature of coldest month,min. T of coldest mo.,year,degrees Celsius,*degree*C*, +bio07,bio07,WorldClim_2.1_UKESM1-0-LL_ssp585_5m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature annual range (bio05-bio06),T ann. Range,year,degrees Celsius,*degree*C*, +bio08,bio08,WorldClim_2.1_UKESM1-0-LL_ssp585_5m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of wettest quarter,mean T of wettest qtr,year,degrees Celsius,*degree*C*, +bio09,bio09,WorldClim_2.1_UKESM1-0-LL_ssp585_5m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of driest quarter,mean T of driest qtr,year,degrees Celsius,*degree*C*, +bio10,bio10,WorldClim_2.1_UKESM1-0-LL_ssp585_5m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of warmest quarter,mean T of warmest qtr,year,degrees Celsius,*degree*C*, +bio11,bio11,WorldClim_2.1_UKESM1-0-LL_ssp585_5m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of coldest quarter,mean T of coldest qtr,year,degrees Celsius,*degree*C*, +bio12,bio12,WorldClim_2.1_UKESM1-0-LL_ssp585_5m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual precipitation,ann. P,year,mm per year,*mm~yr^-1*, +bio13,bio13,WorldClim_2.1_UKESM1-0-LL_ssp585_5m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest month,P of wettest mo.,year,mm per month,*mm~mo^-1*, +bio14,bio14,WorldClim_2.1_UKESM1-0-LL_ssp585_5m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest month,P of driest mo.,year,mm per month,*mm~mo^-1*, +bio15,bio15,WorldClim_2.1_UKESM1-0-LL_ssp585_5m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation seasonality (coeff var),P season.,year,,, +bio16,bio16,WorldClim_2.1_UKESM1-0-LL_ssp585_5m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest quarter,P of wettest qtr,year,mm per quarter,*mm~qtr^-1*, +bio17,bio17,WorldClim_2.1_UKESM1-0-LL_ssp585_5m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest quarter,P of driest qtr,year,mm per quarter,*mm~qtr^-1*, +bio18,bio18,WorldClim_2.1_UKESM1-0-LL_ssp585_5m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of warmest quarter,P of warmest qtr,year,mm per quarter,*mm~qtr^-1*, +bio19,bio19,WorldClim_2.1_UKESM1-0-LL_ssp585_5m,FALSE,WorldClim_2.1_UKESM1-0-LL_ssp585_5m_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of coldest quarter,P of coldest qtr,year,mm per quarter,*mm~qtr^-1*, +precipitation_01,precipitation_01,WorldClim_2.1_UKESM1-0-LL_ssp585_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jan,P Jan,january,mm per month,*mm~mo^-1*, +precipitation_02,precipitation_02,WorldClim_2.1_UKESM1-0-LL_ssp585_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Feb,P Feb,february,mm per month,*mm~mo^-1*, +precipitation_03,precipitation_03,WorldClim_2.1_UKESM1-0-LL_ssp585_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Mar,P Mar,march,mm per month,*mm~mo^-1*, +precipitation_04,precipitation_04,WorldClim_2.1_UKESM1-0-LL_ssp585_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Apr,P Apr,april,mm per month,*mm~mo^-1*, +precipitation_05,precipitation_05,WorldClim_2.1_UKESM1-0-LL_ssp585_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation May,P May,may,mm per month,*mm~mo^-1*, +precipitation_06,precipitation_06,WorldClim_2.1_UKESM1-0-LL_ssp585_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jun,P Jun,june,mm per month,*mm~mo^-1*, +precipitation_07,precipitation_07,WorldClim_2.1_UKESM1-0-LL_ssp585_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jul,P Jul,july,mm per month,*mm~mo^-1*, +precipitation_08,precipitation_08,WorldClim_2.1_UKESM1-0-LL_ssp585_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Aug,P Aug,august,mm per month,*mm~mo^-1*, +precipitation_09,precipitation_09,WorldClim_2.1_UKESM1-0-LL_ssp585_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Sep,P Sep,september,mm per month,*mm~mo^-1*, +precipitation_10,precipitation_10,WorldClim_2.1_UKESM1-0-LL_ssp585_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Oct,P Oct,october,mm per month,*mm~mo^-1*, +precipitation_11,precipitation_11,WorldClim_2.1_UKESM1-0-LL_ssp585_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Nov,P Nov,november,mm per month,*mm~mo^-1*, +precipitation_12,precipitation_12,WorldClim_2.1_UKESM1-0-LL_ssp585_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp585_5m_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Dec,P Dec,december,mm per month,*mm~mo^-1*, +temperature_min_01,temperature_min_01,WorldClim_2.1_UKESM1-0-LL_ssp585_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jan,min T Jan,january,degrees Celsius,*degree*C*, +temperature_min_02,temperature_min_02,WorldClim_2.1_UKESM1-0-LL_ssp585_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Feb,min T Feb,february,degrees Celsius,*degree*C*, +temperature_min_03,temperature_min_03,WorldClim_2.1_UKESM1-0-LL_ssp585_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Mar,min T Mar,march,degrees Celsius,*degree*C*, +temperature_min_04,temperature_min_04,WorldClim_2.1_UKESM1-0-LL_ssp585_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Apr,min T Apr,april,degrees Celsius,*degree*C*, +temperature_min_05,temperature_min_05,WorldClim_2.1_UKESM1-0-LL_ssp585_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature May,min T May,may,degrees Celsius,*degree*C*, +temperature_min_06,temperature_min_06,WorldClim_2.1_UKESM1-0-LL_ssp585_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jun,min T Jun,june,degrees Celsius,*degree*C*, +temperature_min_07,temperature_min_07,WorldClim_2.1_UKESM1-0-LL_ssp585_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jul,min T Jul,july,degrees Celsius,*degree*C*, +temperature_min_08,temperature_min_08,WorldClim_2.1_UKESM1-0-LL_ssp585_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Aug,min T Aug,august,degrees Celsius,*degree*C*, +temperature_min_09,temperature_min_09,WorldClim_2.1_UKESM1-0-LL_ssp585_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Sep,min T Sep,september,degrees Celsius,*degree*C*, +temperature_min_10,temperature_min_10,WorldClim_2.1_UKESM1-0-LL_ssp585_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Oct,min T Oct,october,degrees Celsius,*degree*C*, +temperature_min_11,temperature_min_11,WorldClim_2.1_UKESM1-0-LL_ssp585_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Nov,min T Nov,november,degrees Celsius,*degree*C*, +temperature_min_12,temperature_min_12,WorldClim_2.1_UKESM1-0-LL_ssp585_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp585_5m_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Dec,min T Dec,december,degrees Celsius,*degree*C*, +temperature_max_01,temperature_max_01,WorldClim_2.1_UKESM1-0-LL_ssp585_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jan,max T Jan,january,degrees Celsius,*degree*C*, +temperature_max_02,temperature_max_02,WorldClim_2.1_UKESM1-0-LL_ssp585_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Feb,max T Feb,february,degrees Celsius,*degree*C*, +temperature_max_03,temperature_max_03,WorldClim_2.1_UKESM1-0-LL_ssp585_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Mar,max T Mar,march,degrees Celsius,*degree*C*, +temperature_max_04,temperature_max_04,WorldClim_2.1_UKESM1-0-LL_ssp585_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Apr,max T Apr,april,degrees Celsius,*degree*C*, +temperature_max_05,temperature_max_05,WorldClim_2.1_UKESM1-0-LL_ssp585_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature May,max T May,may,degrees Celsius,*degree*C*, +temperature_max_06,temperature_max_06,WorldClim_2.1_UKESM1-0-LL_ssp585_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jun,max T Jun,june,degrees Celsius,*degree*C*, +temperature_max_07,temperature_max_07,WorldClim_2.1_UKESM1-0-LL_ssp585_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jul,max T Jul,july,degrees Celsius,*degree*C*, +temperature_max_08,temperature_max_08,WorldClim_2.1_UKESM1-0-LL_ssp585_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Aug,max T Aug,august,degrees Celsius,*degree*C*, +temperature_max_09,temperature_max_09,WorldClim_2.1_UKESM1-0-LL_ssp585_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Sep,max T Sep,september,degrees Celsius,*degree*C*, +temperature_max_10,temperature_max_10,WorldClim_2.1_UKESM1-0-LL_ssp585_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Oct,max T Oct,october,degrees Celsius,*degree*C*, +temperature_max_11,temperature_max_11,WorldClim_2.1_UKESM1-0-LL_ssp585_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Nov,max T Nov,november,degrees Celsius,*degree*C*, +temperature_max_12,temperature_max_12,WorldClim_2.1_UKESM1-0-LL_ssp585_5m,TRUE,WorldClim_2.1_UKESM1-0-LL_ssp585_5m_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Dec,max T Dec,december,degrees Celsius,*degree*C*, diff --git a/data-raw/data_files/internal_seas/Caspian_sea.cpg b/data-raw/data_files/internal_seas/Caspian_sea.cpg new file mode 100644 index 00000000..3ad133c0 --- /dev/null +++ b/data-raw/data_files/internal_seas/Caspian_sea.cpg @@ -0,0 +1 @@ +UTF-8 \ No newline at end of file diff --git a/data-raw/data_files/internal_seas/Caspian_sea.dbf b/data-raw/data_files/internal_seas/Caspian_sea.dbf new file mode 100644 index 00000000..5ab6a61a Binary files /dev/null and b/data-raw/data_files/internal_seas/Caspian_sea.dbf differ diff --git a/data-raw/data_files/internal_seas/Caspian_sea.prj b/data-raw/data_files/internal_seas/Caspian_sea.prj new file mode 100644 index 00000000..ad1b7822 --- /dev/null +++ b/data-raw/data_files/internal_seas/Caspian_sea.prj @@ -0,0 +1 @@ +GEOGCS["GCS_WGS_84_CRS84",DATUM["D_WGS_1984",SPHEROID["WGS_1984",6378137.0,298.257223563]],PRIMEM["Greenwich",0.0],UNIT["Degree",0.0174532925199433]] \ No newline at end of file diff --git a/data-raw/data_files/internal_seas/Caspian_sea.qpj b/data-raw/data_files/internal_seas/Caspian_sea.qpj new file mode 100644 index 00000000..14aabd8d --- /dev/null +++ b/data-raw/data_files/internal_seas/Caspian_sea.qpj @@ -0,0 +1 @@ +GEOGCS["WGS 84 (CRS84)",DATUM["WGS_1984",SPHEROID["WGS 84",6378137,298.257223563,AUTHORITY["EPSG","7030"]],AUTHORITY["EPSG","6326"]],PRIMEM["Greenwich",0,AUTHORITY["EPSG","8901"]],UNIT["degree",0.0174532925199433,AUTHORITY["EPSG","9122"]],AUTHORITY["OGC","CRS84"]] diff --git a/data-raw/data_files/internal_seas/Caspian_sea.shp b/data-raw/data_files/internal_seas/Caspian_sea.shp new file mode 100644 index 00000000..943a7a7a Binary files /dev/null and b/data-raw/data_files/internal_seas/Caspian_sea.shp differ diff --git a/data-raw/data_files/internal_seas/Caspian_sea.shx b/data-raw/data_files/internal_seas/Caspian_sea.shx new file mode 100644 index 00000000..ebae3e8c Binary files /dev/null and b/data-raw/data_files/internal_seas/Caspian_sea.shx differ diff --git a/data-raw/data_files/internal_seas/azov_sea.cst b/data-raw/data_files/internal_seas/azov_sea.cst new file mode 100644 index 00000000..cd89cb97 --- /dev/null +++ b/data-raw/data_files/internal_seas/azov_sea.cst @@ -0,0 +1 @@ +ISO-8859-1 \ No newline at end of file diff --git a/data-raw/data_files/internal_seas/azov_sea.dbf b/data-raw/data_files/internal_seas/azov_sea.dbf new file mode 100644 index 00000000..ce47c027 Binary files /dev/null and b/data-raw/data_files/internal_seas/azov_sea.dbf differ diff --git a/data-raw/data_files/internal_seas/azov_sea.prj b/data-raw/data_files/internal_seas/azov_sea.prj new file mode 100644 index 00000000..60bfa862 --- /dev/null +++ b/data-raw/data_files/internal_seas/azov_sea.prj @@ -0,0 +1 @@ +GEOGCS["WGS 84", DATUM["World Geodetic System 1984", SPHEROID["WGS 84", 6378137.0, 298.257223563, AUTHORITY["EPSG","7030"]], AUTHORITY["EPSG","6326"]], PRIMEM["Greenwich", 0.0, AUTHORITY["EPSG","8901"]], UNIT["degree", 0.017453292519943295], AXIS["Geodetic longitude", EAST], AXIS["Geodetic latitude", NORTH], AUTHORITY["EPSG","4326"]] \ No newline at end of file diff --git a/data-raw/data_files/internal_seas/azov_sea.shp b/data-raw/data_files/internal_seas/azov_sea.shp new file mode 100644 index 00000000..d16f99ac Binary files /dev/null and b/data-raw/data_files/internal_seas/azov_sea.shp differ diff --git a/data-raw/data_files/internal_seas/azov_sea.shx b/data-raw/data_files/internal_seas/azov_sea.shx new file mode 100644 index 00000000..4f9fb2fa Binary files /dev/null and b/data-raw/data_files/internal_seas/azov_sea.shx differ diff --git a/data-raw/data_files/internal_seas/black_sea.cst b/data-raw/data_files/internal_seas/black_sea.cst new file mode 100644 index 00000000..cd89cb97 --- /dev/null +++ b/data-raw/data_files/internal_seas/black_sea.cst @@ -0,0 +1 @@ +ISO-8859-1 \ No newline at end of file diff --git a/data-raw/data_files/internal_seas/black_sea.dbf b/data-raw/data_files/internal_seas/black_sea.dbf new file mode 100644 index 00000000..98bd79bf Binary files /dev/null and b/data-raw/data_files/internal_seas/black_sea.dbf differ diff --git a/data-raw/data_files/internal_seas/black_sea.prj b/data-raw/data_files/internal_seas/black_sea.prj new file mode 100644 index 00000000..60bfa862 --- /dev/null +++ b/data-raw/data_files/internal_seas/black_sea.prj @@ -0,0 +1 @@ +GEOGCS["WGS 84", DATUM["World Geodetic System 1984", SPHEROID["WGS 84", 6378137.0, 298.257223563, AUTHORITY["EPSG","7030"]], AUTHORITY["EPSG","6326"]], PRIMEM["Greenwich", 0.0, AUTHORITY["EPSG","8901"]], UNIT["degree", 0.017453292519943295], AXIS["Geodetic longitude", EAST], AXIS["Geodetic latitude", NORTH], AUTHORITY["EPSG","4326"]] \ No newline at end of file diff --git a/data-raw/data_files/internal_seas/black_sea.shp b/data-raw/data_files/internal_seas/black_sea.shp new file mode 100644 index 00000000..2a64d29b Binary files /dev/null and b/data-raw/data_files/internal_seas/black_sea.shp differ diff --git a/data-raw/data_files/internal_seas/black_sea.shx b/data-raw/data_files/internal_seas/black_sea.shx new file mode 100644 index 00000000..e399b6e9 Binary files /dev/null and b/data-raw/data_files/internal_seas/black_sea.shx differ diff --git a/data-raw/data_files/internal_seas/metadata_for_internal_seas b/data-raw/data_files/internal_seas/metadata_for_internal_seas new file mode 100644 index 00000000..c1594b63 --- /dev/null +++ b/data-raw/data_files/internal_seas/metadata_for_internal_seas @@ -0,0 +1,8 @@ +Black sea downloaded from: +https://www.marineregions.org/gazetteer.php?p=details&id=3319 + +Caspian sea downloaded from: +https://www.marineregions.org/gazetteer.php?p=details&id=4282 + +Sea of Azov downloaded from: +https://www.marineregions.org/gazetteer.php?p=details&id=3320 diff --git a/data-raw/data_files/shapefiles_internal_seas.zip b/data-raw/data_files/shapefiles_internal_seas.zip index 842fc874..27c9cf63 100644 Binary files a/data-raw/data_files/shapefiles_internal_seas.zip and b/data-raw/data_files/shapefiles_internal_seas.zip differ diff --git a/data-raw/data_files/worldclim_future_list.csv b/data-raw/data_files/worldclim_future_list.csv new file mode 100644 index 00000000..bbe28c75 --- /dev/null +++ b/data-raw/data_files/worldclim_future_list.csv @@ -0,0 +1,6161 @@ +"variable","ncvar","dataset","monthly","file_name","download_path","download_function","file_name_orig","download_path_orig","version","long_name","abbreviated_name","time_frame","units","units_exp","dataset_list_v" +"bio01","bio01","WorldClim_2.1_ACCESS-CM2_ssp126_10m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual mean temperature","ann. mean T","year","degrees Celsius","*degree*C*", +"bio02","bio02","WorldClim_2.1_ACCESS-CM2_ssp126_10m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean diurnal range","diurn. range","year","degrees Celsius","*degree*C*", +"bio03","bio03","WorldClim_2.1_ACCESS-CM2_ssp126_10m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","isothermality","isothermality","year","","", +"bio04","bio04","WorldClim_2.1_ACCESS-CM2_ssp126_10m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature seasonality","T season.","year","degrees Celsius","*degree*C*", +"bio05","bio05","WorldClim_2.1_ACCESS-CM2_ssp126_10m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature of warmest month","max. T of warmest mo.","year","degrees Celsius","*degree*C*", +"bio06","bio06","WorldClim_2.1_ACCESS-CM2_ssp126_10m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature of coldest month","min. T of coldest mo.","year","degrees Celsius","*degree*C*", +"bio07","bio07","WorldClim_2.1_ACCESS-CM2_ssp126_10m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature annual range (bio05-bio06)","T ann. Range","year","degrees Celsius","*degree*C*", +"bio08","bio08","WorldClim_2.1_ACCESS-CM2_ssp126_10m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of wettest quarter","mean T of wettest qtr","year","degrees Celsius","*degree*C*", +"bio09","bio09","WorldClim_2.1_ACCESS-CM2_ssp126_10m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of driest quarter","mean T of driest qtr","year","degrees Celsius","*degree*C*", +"bio10","bio10","WorldClim_2.1_ACCESS-CM2_ssp126_10m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of warmest quarter","mean T of warmest qtr","year","degrees Celsius","*degree*C*", +"bio11","bio11","WorldClim_2.1_ACCESS-CM2_ssp126_10m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of coldest quarter","mean T of coldest qtr","year","degrees Celsius","*degree*C*", +"bio12","bio12","WorldClim_2.1_ACCESS-CM2_ssp126_10m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual precipitation","ann. P","year","mm per year","*mm~yr^-1*", +"bio13","bio13","WorldClim_2.1_ACCESS-CM2_ssp126_10m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest month","P of wettest mo.","year","mm per month","*mm~mo^-1*", +"bio14","bio14","WorldClim_2.1_ACCESS-CM2_ssp126_10m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest month","P of driest mo.","year","mm per month","*mm~mo^-1*", +"bio15","bio15","WorldClim_2.1_ACCESS-CM2_ssp126_10m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation seasonality (coeff var)","P season.","year","","", +"bio16","bio16","WorldClim_2.1_ACCESS-CM2_ssp126_10m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest quarter","P of wettest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio17","bio17","WorldClim_2.1_ACCESS-CM2_ssp126_10m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest quarter","P of driest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio18","bio18","WorldClim_2.1_ACCESS-CM2_ssp126_10m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of warmest quarter","P of warmest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio19","bio19","WorldClim_2.1_ACCESS-CM2_ssp126_10m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of coldest quarter","P of coldest qtr","year","mm per quarter","*mm~qtr^-1*", +"precipitation_01","precipitation_01","WorldClim_2.1_ACCESS-CM2_ssp126_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jan","P Jan","january","mm per month","*mm~mo^-1*", +"precipitation_02","precipitation_02","WorldClim_2.1_ACCESS-CM2_ssp126_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Feb","P Feb","february","mm per month","*mm~mo^-1*", +"precipitation_03","precipitation_03","WorldClim_2.1_ACCESS-CM2_ssp126_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Mar","P Mar","march","mm per month","*mm~mo^-1*", +"precipitation_04","precipitation_04","WorldClim_2.1_ACCESS-CM2_ssp126_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Apr","P Apr","april","mm per month","*mm~mo^-1*", +"precipitation_05","precipitation_05","WorldClim_2.1_ACCESS-CM2_ssp126_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation May","P May","may","mm per month","*mm~mo^-1*", +"precipitation_06","precipitation_06","WorldClim_2.1_ACCESS-CM2_ssp126_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jun","P Jun","june","mm per month","*mm~mo^-1*", +"precipitation_07","precipitation_07","WorldClim_2.1_ACCESS-CM2_ssp126_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jul","P Jul","july","mm per month","*mm~mo^-1*", +"precipitation_08","precipitation_08","WorldClim_2.1_ACCESS-CM2_ssp126_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Aug","P Aug","august","mm per month","*mm~mo^-1*", +"precipitation_09","precipitation_09","WorldClim_2.1_ACCESS-CM2_ssp126_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Sep","P Sep","september","mm per month","*mm~mo^-1*", +"precipitation_10","precipitation_10","WorldClim_2.1_ACCESS-CM2_ssp126_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Oct","P Oct","october","mm per month","*mm~mo^-1*", +"precipitation_11","precipitation_11","WorldClim_2.1_ACCESS-CM2_ssp126_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Nov","P Nov","november","mm per month","*mm~mo^-1*", +"precipitation_12","precipitation_12","WorldClim_2.1_ACCESS-CM2_ssp126_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Dec","P Dec","december","mm per month","*mm~mo^-1*", +"temperature_min_01","temperature_min_01","WorldClim_2.1_ACCESS-CM2_ssp126_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jan","min T Jan","january","degrees Celsius","*degree*C*", +"temperature_min_02","temperature_min_02","WorldClim_2.1_ACCESS-CM2_ssp126_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Feb","min T Feb","february","degrees Celsius","*degree*C*", +"temperature_min_03","temperature_min_03","WorldClim_2.1_ACCESS-CM2_ssp126_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Mar","min T Mar","march","degrees Celsius","*degree*C*", +"temperature_min_04","temperature_min_04","WorldClim_2.1_ACCESS-CM2_ssp126_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Apr","min T Apr","april","degrees Celsius","*degree*C*", +"temperature_min_05","temperature_min_05","WorldClim_2.1_ACCESS-CM2_ssp126_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature May","min T May","may","degrees Celsius","*degree*C*", +"temperature_min_06","temperature_min_06","WorldClim_2.1_ACCESS-CM2_ssp126_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jun","min T Jun","june","degrees Celsius","*degree*C*", +"temperature_min_07","temperature_min_07","WorldClim_2.1_ACCESS-CM2_ssp126_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jul","min T Jul","july","degrees Celsius","*degree*C*", +"temperature_min_08","temperature_min_08","WorldClim_2.1_ACCESS-CM2_ssp126_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Aug","min T Aug","august","degrees Celsius","*degree*C*", +"temperature_min_09","temperature_min_09","WorldClim_2.1_ACCESS-CM2_ssp126_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Sep","min T Sep","september","degrees Celsius","*degree*C*", +"temperature_min_10","temperature_min_10","WorldClim_2.1_ACCESS-CM2_ssp126_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Oct","min T Oct","october","degrees Celsius","*degree*C*", +"temperature_min_11","temperature_min_11","WorldClim_2.1_ACCESS-CM2_ssp126_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Nov","min T Nov","november","degrees Celsius","*degree*C*", +"temperature_min_12","temperature_min_12","WorldClim_2.1_ACCESS-CM2_ssp126_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Dec","min T Dec","december","degrees Celsius","*degree*C*", +"temperature_max_01","temperature_max_01","WorldClim_2.1_ACCESS-CM2_ssp126_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jan","max T Jan","january","degrees Celsius","*degree*C*", +"temperature_max_02","temperature_max_02","WorldClim_2.1_ACCESS-CM2_ssp126_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Feb","max T Feb","february","degrees Celsius","*degree*C*", +"temperature_max_03","temperature_max_03","WorldClim_2.1_ACCESS-CM2_ssp126_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Mar","max T Mar","march","degrees Celsius","*degree*C*", +"temperature_max_04","temperature_max_04","WorldClim_2.1_ACCESS-CM2_ssp126_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Apr","max T Apr","april","degrees Celsius","*degree*C*", +"temperature_max_05","temperature_max_05","WorldClim_2.1_ACCESS-CM2_ssp126_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature May","max T May","may","degrees Celsius","*degree*C*", +"temperature_max_06","temperature_max_06","WorldClim_2.1_ACCESS-CM2_ssp126_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jun","max T Jun","june","degrees Celsius","*degree*C*", +"temperature_max_07","temperature_max_07","WorldClim_2.1_ACCESS-CM2_ssp126_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jul","max T Jul","july","degrees Celsius","*degree*C*", +"temperature_max_08","temperature_max_08","WorldClim_2.1_ACCESS-CM2_ssp126_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Aug","max T Aug","august","degrees Celsius","*degree*C*", +"temperature_max_09","temperature_max_09","WorldClim_2.1_ACCESS-CM2_ssp126_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Sep","max T Sep","september","degrees Celsius","*degree*C*", +"temperature_max_10","temperature_max_10","WorldClim_2.1_ACCESS-CM2_ssp126_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Oct","max T Oct","october","degrees Celsius","*degree*C*", +"temperature_max_11","temperature_max_11","WorldClim_2.1_ACCESS-CM2_ssp126_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Nov","max T Nov","november","degrees Celsius","*degree*C*", +"temperature_max_12","temperature_max_12","WorldClim_2.1_ACCESS-CM2_ssp126_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Dec","max T Dec","december","degrees Celsius","*degree*C*", +"bio01","bio01","WorldClim_2.1_ACCESS-CM2_ssp126_5m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual mean temperature","ann. mean T","year","degrees Celsius","*degree*C*", +"bio02","bio02","WorldClim_2.1_ACCESS-CM2_ssp126_5m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean diurnal range","diurn. range","year","degrees Celsius","*degree*C*", +"bio03","bio03","WorldClim_2.1_ACCESS-CM2_ssp126_5m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","isothermality","isothermality","year","","", +"bio04","bio04","WorldClim_2.1_ACCESS-CM2_ssp126_5m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature seasonality","T season.","year","degrees Celsius","*degree*C*", +"bio05","bio05","WorldClim_2.1_ACCESS-CM2_ssp126_5m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature of warmest month","max. T of warmest mo.","year","degrees Celsius","*degree*C*", +"bio06","bio06","WorldClim_2.1_ACCESS-CM2_ssp126_5m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature of coldest month","min. T of coldest mo.","year","degrees Celsius","*degree*C*", +"bio07","bio07","WorldClim_2.1_ACCESS-CM2_ssp126_5m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature annual range (bio05-bio06)","T ann. Range","year","degrees Celsius","*degree*C*", +"bio08","bio08","WorldClim_2.1_ACCESS-CM2_ssp126_5m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of wettest quarter","mean T of wettest qtr","year","degrees Celsius","*degree*C*", +"bio09","bio09","WorldClim_2.1_ACCESS-CM2_ssp126_5m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of driest quarter","mean T of driest qtr","year","degrees Celsius","*degree*C*", +"bio10","bio10","WorldClim_2.1_ACCESS-CM2_ssp126_5m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of warmest quarter","mean T of warmest qtr","year","degrees Celsius","*degree*C*", +"bio11","bio11","WorldClim_2.1_ACCESS-CM2_ssp126_5m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of coldest quarter","mean T of coldest qtr","year","degrees Celsius","*degree*C*", +"bio12","bio12","WorldClim_2.1_ACCESS-CM2_ssp126_5m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual precipitation","ann. P","year","mm per year","*mm~yr^-1*", +"bio13","bio13","WorldClim_2.1_ACCESS-CM2_ssp126_5m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest month","P of wettest mo.","year","mm per month","*mm~mo^-1*", +"bio14","bio14","WorldClim_2.1_ACCESS-CM2_ssp126_5m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest month","P of driest mo.","year","mm per month","*mm~mo^-1*", +"bio15","bio15","WorldClim_2.1_ACCESS-CM2_ssp126_5m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation seasonality (coeff var)","P season.","year","","", +"bio16","bio16","WorldClim_2.1_ACCESS-CM2_ssp126_5m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest quarter","P of wettest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio17","bio17","WorldClim_2.1_ACCESS-CM2_ssp126_5m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest quarter","P of driest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio18","bio18","WorldClim_2.1_ACCESS-CM2_ssp126_5m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of warmest quarter","P of warmest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio19","bio19","WorldClim_2.1_ACCESS-CM2_ssp126_5m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of coldest quarter","P of coldest qtr","year","mm per quarter","*mm~qtr^-1*", +"precipitation_01","precipitation_01","WorldClim_2.1_ACCESS-CM2_ssp126_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jan","P Jan","january","mm per month","*mm~mo^-1*", +"precipitation_02","precipitation_02","WorldClim_2.1_ACCESS-CM2_ssp126_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Feb","P Feb","february","mm per month","*mm~mo^-1*", +"precipitation_03","precipitation_03","WorldClim_2.1_ACCESS-CM2_ssp126_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Mar","P Mar","march","mm per month","*mm~mo^-1*", +"precipitation_04","precipitation_04","WorldClim_2.1_ACCESS-CM2_ssp126_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Apr","P Apr","april","mm per month","*mm~mo^-1*", +"precipitation_05","precipitation_05","WorldClim_2.1_ACCESS-CM2_ssp126_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation May","P May","may","mm per month","*mm~mo^-1*", +"precipitation_06","precipitation_06","WorldClim_2.1_ACCESS-CM2_ssp126_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jun","P Jun","june","mm per month","*mm~mo^-1*", +"precipitation_07","precipitation_07","WorldClim_2.1_ACCESS-CM2_ssp126_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jul","P Jul","july","mm per month","*mm~mo^-1*", +"precipitation_08","precipitation_08","WorldClim_2.1_ACCESS-CM2_ssp126_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Aug","P Aug","august","mm per month","*mm~mo^-1*", +"precipitation_09","precipitation_09","WorldClim_2.1_ACCESS-CM2_ssp126_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Sep","P Sep","september","mm per month","*mm~mo^-1*", +"precipitation_10","precipitation_10","WorldClim_2.1_ACCESS-CM2_ssp126_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Oct","P Oct","october","mm per month","*mm~mo^-1*", +"precipitation_11","precipitation_11","WorldClim_2.1_ACCESS-CM2_ssp126_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Nov","P Nov","november","mm per month","*mm~mo^-1*", +"precipitation_12","precipitation_12","WorldClim_2.1_ACCESS-CM2_ssp126_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Dec","P Dec","december","mm per month","*mm~mo^-1*", +"temperature_min_01","temperature_min_01","WorldClim_2.1_ACCESS-CM2_ssp126_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jan","min T Jan","january","degrees Celsius","*degree*C*", +"temperature_min_02","temperature_min_02","WorldClim_2.1_ACCESS-CM2_ssp126_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Feb","min T Feb","february","degrees Celsius","*degree*C*", +"temperature_min_03","temperature_min_03","WorldClim_2.1_ACCESS-CM2_ssp126_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Mar","min T Mar","march","degrees Celsius","*degree*C*", +"temperature_min_04","temperature_min_04","WorldClim_2.1_ACCESS-CM2_ssp126_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Apr","min T Apr","april","degrees Celsius","*degree*C*", +"temperature_min_05","temperature_min_05","WorldClim_2.1_ACCESS-CM2_ssp126_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature May","min T May","may","degrees Celsius","*degree*C*", +"temperature_min_06","temperature_min_06","WorldClim_2.1_ACCESS-CM2_ssp126_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jun","min T Jun","june","degrees Celsius","*degree*C*", +"temperature_min_07","temperature_min_07","WorldClim_2.1_ACCESS-CM2_ssp126_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jul","min T Jul","july","degrees Celsius","*degree*C*", +"temperature_min_08","temperature_min_08","WorldClim_2.1_ACCESS-CM2_ssp126_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Aug","min T Aug","august","degrees Celsius","*degree*C*", +"temperature_min_09","temperature_min_09","WorldClim_2.1_ACCESS-CM2_ssp126_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Sep","min T Sep","september","degrees Celsius","*degree*C*", +"temperature_min_10","temperature_min_10","WorldClim_2.1_ACCESS-CM2_ssp126_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Oct","min T Oct","october","degrees Celsius","*degree*C*", +"temperature_min_11","temperature_min_11","WorldClim_2.1_ACCESS-CM2_ssp126_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Nov","min T Nov","november","degrees Celsius","*degree*C*", +"temperature_min_12","temperature_min_12","WorldClim_2.1_ACCESS-CM2_ssp126_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Dec","min T Dec","december","degrees Celsius","*degree*C*", +"temperature_max_01","temperature_max_01","WorldClim_2.1_ACCESS-CM2_ssp126_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jan","max T Jan","january","degrees Celsius","*degree*C*", +"temperature_max_02","temperature_max_02","WorldClim_2.1_ACCESS-CM2_ssp126_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Feb","max T Feb","february","degrees Celsius","*degree*C*", +"temperature_max_03","temperature_max_03","WorldClim_2.1_ACCESS-CM2_ssp126_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Mar","max T Mar","march","degrees Celsius","*degree*C*", +"temperature_max_04","temperature_max_04","WorldClim_2.1_ACCESS-CM2_ssp126_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Apr","max T Apr","april","degrees Celsius","*degree*C*", +"temperature_max_05","temperature_max_05","WorldClim_2.1_ACCESS-CM2_ssp126_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature May","max T May","may","degrees Celsius","*degree*C*", +"temperature_max_06","temperature_max_06","WorldClim_2.1_ACCESS-CM2_ssp126_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jun","max T Jun","june","degrees Celsius","*degree*C*", +"temperature_max_07","temperature_max_07","WorldClim_2.1_ACCESS-CM2_ssp126_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jul","max T Jul","july","degrees Celsius","*degree*C*", +"temperature_max_08","temperature_max_08","WorldClim_2.1_ACCESS-CM2_ssp126_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Aug","max T Aug","august","degrees Celsius","*degree*C*", +"temperature_max_09","temperature_max_09","WorldClim_2.1_ACCESS-CM2_ssp126_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Sep","max T Sep","september","degrees Celsius","*degree*C*", +"temperature_max_10","temperature_max_10","WorldClim_2.1_ACCESS-CM2_ssp126_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Oct","max T Oct","october","degrees Celsius","*degree*C*", +"temperature_max_11","temperature_max_11","WorldClim_2.1_ACCESS-CM2_ssp126_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Nov","max T Nov","november","degrees Celsius","*degree*C*", +"temperature_max_12","temperature_max_12","WorldClim_2.1_ACCESS-CM2_ssp126_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Dec","max T Dec","december","degrees Celsius","*degree*C*", +"bio01","bio01","WorldClim_2.1_ACCESS-CM2_ssp245_10m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual mean temperature","ann. mean T","year","degrees Celsius","*degree*C*", +"bio02","bio02","WorldClim_2.1_ACCESS-CM2_ssp245_10m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean diurnal range","diurn. range","year","degrees Celsius","*degree*C*", +"bio03","bio03","WorldClim_2.1_ACCESS-CM2_ssp245_10m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","isothermality","isothermality","year","","", +"bio04","bio04","WorldClim_2.1_ACCESS-CM2_ssp245_10m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature seasonality","T season.","year","degrees Celsius","*degree*C*", +"bio05","bio05","WorldClim_2.1_ACCESS-CM2_ssp245_10m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature of warmest month","max. T of warmest mo.","year","degrees Celsius","*degree*C*", +"bio06","bio06","WorldClim_2.1_ACCESS-CM2_ssp245_10m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature of coldest month","min. T of coldest mo.","year","degrees Celsius","*degree*C*", +"bio07","bio07","WorldClim_2.1_ACCESS-CM2_ssp245_10m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature annual range (bio05-bio06)","T ann. Range","year","degrees Celsius","*degree*C*", +"bio08","bio08","WorldClim_2.1_ACCESS-CM2_ssp245_10m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of wettest quarter","mean T of wettest qtr","year","degrees Celsius","*degree*C*", +"bio09","bio09","WorldClim_2.1_ACCESS-CM2_ssp245_10m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of driest quarter","mean T of driest qtr","year","degrees Celsius","*degree*C*", +"bio10","bio10","WorldClim_2.1_ACCESS-CM2_ssp245_10m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of warmest quarter","mean T of warmest qtr","year","degrees Celsius","*degree*C*", +"bio11","bio11","WorldClim_2.1_ACCESS-CM2_ssp245_10m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of coldest quarter","mean T of coldest qtr","year","degrees Celsius","*degree*C*", +"bio12","bio12","WorldClim_2.1_ACCESS-CM2_ssp245_10m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual precipitation","ann. P","year","mm per year","*mm~yr^-1*", +"bio13","bio13","WorldClim_2.1_ACCESS-CM2_ssp245_10m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest month","P of wettest mo.","year","mm per month","*mm~mo^-1*", +"bio14","bio14","WorldClim_2.1_ACCESS-CM2_ssp245_10m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest month","P of driest mo.","year","mm per month","*mm~mo^-1*", +"bio15","bio15","WorldClim_2.1_ACCESS-CM2_ssp245_10m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation seasonality (coeff var)","P season.","year","","", +"bio16","bio16","WorldClim_2.1_ACCESS-CM2_ssp245_10m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest quarter","P of wettest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio17","bio17","WorldClim_2.1_ACCESS-CM2_ssp245_10m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest quarter","P of driest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio18","bio18","WorldClim_2.1_ACCESS-CM2_ssp245_10m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of warmest quarter","P of warmest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio19","bio19","WorldClim_2.1_ACCESS-CM2_ssp245_10m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of coldest quarter","P of coldest qtr","year","mm per quarter","*mm~qtr^-1*", +"precipitation_01","precipitation_01","WorldClim_2.1_ACCESS-CM2_ssp245_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jan","P Jan","january","mm per month","*mm~mo^-1*", +"precipitation_02","precipitation_02","WorldClim_2.1_ACCESS-CM2_ssp245_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Feb","P Feb","february","mm per month","*mm~mo^-1*", +"precipitation_03","precipitation_03","WorldClim_2.1_ACCESS-CM2_ssp245_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Mar","P Mar","march","mm per month","*mm~mo^-1*", +"precipitation_04","precipitation_04","WorldClim_2.1_ACCESS-CM2_ssp245_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Apr","P Apr","april","mm per month","*mm~mo^-1*", +"precipitation_05","precipitation_05","WorldClim_2.1_ACCESS-CM2_ssp245_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation May","P May","may","mm per month","*mm~mo^-1*", +"precipitation_06","precipitation_06","WorldClim_2.1_ACCESS-CM2_ssp245_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jun","P Jun","june","mm per month","*mm~mo^-1*", +"precipitation_07","precipitation_07","WorldClim_2.1_ACCESS-CM2_ssp245_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jul","P Jul","july","mm per month","*mm~mo^-1*", +"precipitation_08","precipitation_08","WorldClim_2.1_ACCESS-CM2_ssp245_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Aug","P Aug","august","mm per month","*mm~mo^-1*", +"precipitation_09","precipitation_09","WorldClim_2.1_ACCESS-CM2_ssp245_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Sep","P Sep","september","mm per month","*mm~mo^-1*", +"precipitation_10","precipitation_10","WorldClim_2.1_ACCESS-CM2_ssp245_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Oct","P Oct","october","mm per month","*mm~mo^-1*", +"precipitation_11","precipitation_11","WorldClim_2.1_ACCESS-CM2_ssp245_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Nov","P Nov","november","mm per month","*mm~mo^-1*", +"precipitation_12","precipitation_12","WorldClim_2.1_ACCESS-CM2_ssp245_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Dec","P Dec","december","mm per month","*mm~mo^-1*", +"temperature_min_01","temperature_min_01","WorldClim_2.1_ACCESS-CM2_ssp245_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jan","min T Jan","january","degrees Celsius","*degree*C*", +"temperature_min_02","temperature_min_02","WorldClim_2.1_ACCESS-CM2_ssp245_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Feb","min T Feb","february","degrees Celsius","*degree*C*", +"temperature_min_03","temperature_min_03","WorldClim_2.1_ACCESS-CM2_ssp245_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Mar","min T Mar","march","degrees Celsius","*degree*C*", +"temperature_min_04","temperature_min_04","WorldClim_2.1_ACCESS-CM2_ssp245_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Apr","min T Apr","april","degrees Celsius","*degree*C*", +"temperature_min_05","temperature_min_05","WorldClim_2.1_ACCESS-CM2_ssp245_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature May","min T May","may","degrees Celsius","*degree*C*", +"temperature_min_06","temperature_min_06","WorldClim_2.1_ACCESS-CM2_ssp245_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jun","min T Jun","june","degrees Celsius","*degree*C*", +"temperature_min_07","temperature_min_07","WorldClim_2.1_ACCESS-CM2_ssp245_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jul","min T Jul","july","degrees Celsius","*degree*C*", +"temperature_min_08","temperature_min_08","WorldClim_2.1_ACCESS-CM2_ssp245_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Aug","min T Aug","august","degrees Celsius","*degree*C*", +"temperature_min_09","temperature_min_09","WorldClim_2.1_ACCESS-CM2_ssp245_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Sep","min T Sep","september","degrees Celsius","*degree*C*", +"temperature_min_10","temperature_min_10","WorldClim_2.1_ACCESS-CM2_ssp245_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Oct","min T Oct","october","degrees Celsius","*degree*C*", +"temperature_min_11","temperature_min_11","WorldClim_2.1_ACCESS-CM2_ssp245_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Nov","min T Nov","november","degrees Celsius","*degree*C*", +"temperature_min_12","temperature_min_12","WorldClim_2.1_ACCESS-CM2_ssp245_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Dec","min T Dec","december","degrees Celsius","*degree*C*", +"temperature_max_01","temperature_max_01","WorldClim_2.1_ACCESS-CM2_ssp245_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jan","max T Jan","january","degrees Celsius","*degree*C*", +"temperature_max_02","temperature_max_02","WorldClim_2.1_ACCESS-CM2_ssp245_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Feb","max T Feb","february","degrees Celsius","*degree*C*", +"temperature_max_03","temperature_max_03","WorldClim_2.1_ACCESS-CM2_ssp245_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Mar","max T Mar","march","degrees Celsius","*degree*C*", +"temperature_max_04","temperature_max_04","WorldClim_2.1_ACCESS-CM2_ssp245_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Apr","max T Apr","april","degrees Celsius","*degree*C*", +"temperature_max_05","temperature_max_05","WorldClim_2.1_ACCESS-CM2_ssp245_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature May","max T May","may","degrees Celsius","*degree*C*", +"temperature_max_06","temperature_max_06","WorldClim_2.1_ACCESS-CM2_ssp245_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jun","max T Jun","june","degrees Celsius","*degree*C*", +"temperature_max_07","temperature_max_07","WorldClim_2.1_ACCESS-CM2_ssp245_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jul","max T Jul","july","degrees Celsius","*degree*C*", +"temperature_max_08","temperature_max_08","WorldClim_2.1_ACCESS-CM2_ssp245_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Aug","max T Aug","august","degrees Celsius","*degree*C*", +"temperature_max_09","temperature_max_09","WorldClim_2.1_ACCESS-CM2_ssp245_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Sep","max T Sep","september","degrees Celsius","*degree*C*", +"temperature_max_10","temperature_max_10","WorldClim_2.1_ACCESS-CM2_ssp245_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Oct","max T Oct","october","degrees Celsius","*degree*C*", +"temperature_max_11","temperature_max_11","WorldClim_2.1_ACCESS-CM2_ssp245_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Nov","max T Nov","november","degrees Celsius","*degree*C*", +"temperature_max_12","temperature_max_12","WorldClim_2.1_ACCESS-CM2_ssp245_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Dec","max T Dec","december","degrees Celsius","*degree*C*", +"bio01","bio01","WorldClim_2.1_ACCESS-CM2_ssp245_5m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual mean temperature","ann. mean T","year","degrees Celsius","*degree*C*", +"bio02","bio02","WorldClim_2.1_ACCESS-CM2_ssp245_5m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean diurnal range","diurn. range","year","degrees Celsius","*degree*C*", +"bio03","bio03","WorldClim_2.1_ACCESS-CM2_ssp245_5m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","isothermality","isothermality","year","","", +"bio04","bio04","WorldClim_2.1_ACCESS-CM2_ssp245_5m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature seasonality","T season.","year","degrees Celsius","*degree*C*", +"bio05","bio05","WorldClim_2.1_ACCESS-CM2_ssp245_5m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature of warmest month","max. T of warmest mo.","year","degrees Celsius","*degree*C*", +"bio06","bio06","WorldClim_2.1_ACCESS-CM2_ssp245_5m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature of coldest month","min. T of coldest mo.","year","degrees Celsius","*degree*C*", +"bio07","bio07","WorldClim_2.1_ACCESS-CM2_ssp245_5m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature annual range (bio05-bio06)","T ann. Range","year","degrees Celsius","*degree*C*", +"bio08","bio08","WorldClim_2.1_ACCESS-CM2_ssp245_5m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of wettest quarter","mean T of wettest qtr","year","degrees Celsius","*degree*C*", +"bio09","bio09","WorldClim_2.1_ACCESS-CM2_ssp245_5m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of driest quarter","mean T of driest qtr","year","degrees Celsius","*degree*C*", +"bio10","bio10","WorldClim_2.1_ACCESS-CM2_ssp245_5m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of warmest quarter","mean T of warmest qtr","year","degrees Celsius","*degree*C*", +"bio11","bio11","WorldClim_2.1_ACCESS-CM2_ssp245_5m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of coldest quarter","mean T of coldest qtr","year","degrees Celsius","*degree*C*", +"bio12","bio12","WorldClim_2.1_ACCESS-CM2_ssp245_5m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual precipitation","ann. P","year","mm per year","*mm~yr^-1*", +"bio13","bio13","WorldClim_2.1_ACCESS-CM2_ssp245_5m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest month","P of wettest mo.","year","mm per month","*mm~mo^-1*", +"bio14","bio14","WorldClim_2.1_ACCESS-CM2_ssp245_5m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest month","P of driest mo.","year","mm per month","*mm~mo^-1*", +"bio15","bio15","WorldClim_2.1_ACCESS-CM2_ssp245_5m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation seasonality (coeff var)","P season.","year","","", +"bio16","bio16","WorldClim_2.1_ACCESS-CM2_ssp245_5m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest quarter","P of wettest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio17","bio17","WorldClim_2.1_ACCESS-CM2_ssp245_5m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest quarter","P of driest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio18","bio18","WorldClim_2.1_ACCESS-CM2_ssp245_5m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of warmest quarter","P of warmest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio19","bio19","WorldClim_2.1_ACCESS-CM2_ssp245_5m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of coldest quarter","P of coldest qtr","year","mm per quarter","*mm~qtr^-1*", +"precipitation_01","precipitation_01","WorldClim_2.1_ACCESS-CM2_ssp245_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jan","P Jan","january","mm per month","*mm~mo^-1*", +"precipitation_02","precipitation_02","WorldClim_2.1_ACCESS-CM2_ssp245_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Feb","P Feb","february","mm per month","*mm~mo^-1*", +"precipitation_03","precipitation_03","WorldClim_2.1_ACCESS-CM2_ssp245_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Mar","P Mar","march","mm per month","*mm~mo^-1*", +"precipitation_04","precipitation_04","WorldClim_2.1_ACCESS-CM2_ssp245_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Apr","P Apr","april","mm per month","*mm~mo^-1*", +"precipitation_05","precipitation_05","WorldClim_2.1_ACCESS-CM2_ssp245_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation May","P May","may","mm per month","*mm~mo^-1*", +"precipitation_06","precipitation_06","WorldClim_2.1_ACCESS-CM2_ssp245_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jun","P Jun","june","mm per month","*mm~mo^-1*", +"precipitation_07","precipitation_07","WorldClim_2.1_ACCESS-CM2_ssp245_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jul","P Jul","july","mm per month","*mm~mo^-1*", +"precipitation_08","precipitation_08","WorldClim_2.1_ACCESS-CM2_ssp245_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Aug","P Aug","august","mm per month","*mm~mo^-1*", +"precipitation_09","precipitation_09","WorldClim_2.1_ACCESS-CM2_ssp245_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Sep","P Sep","september","mm per month","*mm~mo^-1*", +"precipitation_10","precipitation_10","WorldClim_2.1_ACCESS-CM2_ssp245_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Oct","P Oct","october","mm per month","*mm~mo^-1*", +"precipitation_11","precipitation_11","WorldClim_2.1_ACCESS-CM2_ssp245_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Nov","P Nov","november","mm per month","*mm~mo^-1*", +"precipitation_12","precipitation_12","WorldClim_2.1_ACCESS-CM2_ssp245_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Dec","P Dec","december","mm per month","*mm~mo^-1*", +"temperature_min_01","temperature_min_01","WorldClim_2.1_ACCESS-CM2_ssp245_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jan","min T Jan","january","degrees Celsius","*degree*C*", +"temperature_min_02","temperature_min_02","WorldClim_2.1_ACCESS-CM2_ssp245_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Feb","min T Feb","february","degrees Celsius","*degree*C*", +"temperature_min_03","temperature_min_03","WorldClim_2.1_ACCESS-CM2_ssp245_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Mar","min T Mar","march","degrees Celsius","*degree*C*", +"temperature_min_04","temperature_min_04","WorldClim_2.1_ACCESS-CM2_ssp245_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Apr","min T Apr","april","degrees Celsius","*degree*C*", +"temperature_min_05","temperature_min_05","WorldClim_2.1_ACCESS-CM2_ssp245_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature May","min T May","may","degrees Celsius","*degree*C*", +"temperature_min_06","temperature_min_06","WorldClim_2.1_ACCESS-CM2_ssp245_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jun","min T Jun","june","degrees Celsius","*degree*C*", +"temperature_min_07","temperature_min_07","WorldClim_2.1_ACCESS-CM2_ssp245_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jul","min T Jul","july","degrees Celsius","*degree*C*", +"temperature_min_08","temperature_min_08","WorldClim_2.1_ACCESS-CM2_ssp245_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Aug","min T Aug","august","degrees Celsius","*degree*C*", +"temperature_min_09","temperature_min_09","WorldClim_2.1_ACCESS-CM2_ssp245_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Sep","min T Sep","september","degrees Celsius","*degree*C*", +"temperature_min_10","temperature_min_10","WorldClim_2.1_ACCESS-CM2_ssp245_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Oct","min T Oct","october","degrees Celsius","*degree*C*", +"temperature_min_11","temperature_min_11","WorldClim_2.1_ACCESS-CM2_ssp245_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Nov","min T Nov","november","degrees Celsius","*degree*C*", +"temperature_min_12","temperature_min_12","WorldClim_2.1_ACCESS-CM2_ssp245_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Dec","min T Dec","december","degrees Celsius","*degree*C*", +"temperature_max_01","temperature_max_01","WorldClim_2.1_ACCESS-CM2_ssp245_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jan","max T Jan","january","degrees Celsius","*degree*C*", +"temperature_max_02","temperature_max_02","WorldClim_2.1_ACCESS-CM2_ssp245_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Feb","max T Feb","february","degrees Celsius","*degree*C*", +"temperature_max_03","temperature_max_03","WorldClim_2.1_ACCESS-CM2_ssp245_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Mar","max T Mar","march","degrees Celsius","*degree*C*", +"temperature_max_04","temperature_max_04","WorldClim_2.1_ACCESS-CM2_ssp245_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Apr","max T Apr","april","degrees Celsius","*degree*C*", +"temperature_max_05","temperature_max_05","WorldClim_2.1_ACCESS-CM2_ssp245_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature May","max T May","may","degrees Celsius","*degree*C*", +"temperature_max_06","temperature_max_06","WorldClim_2.1_ACCESS-CM2_ssp245_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jun","max T Jun","june","degrees Celsius","*degree*C*", +"temperature_max_07","temperature_max_07","WorldClim_2.1_ACCESS-CM2_ssp245_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jul","max T Jul","july","degrees Celsius","*degree*C*", +"temperature_max_08","temperature_max_08","WorldClim_2.1_ACCESS-CM2_ssp245_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Aug","max T Aug","august","degrees Celsius","*degree*C*", +"temperature_max_09","temperature_max_09","WorldClim_2.1_ACCESS-CM2_ssp245_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Sep","max T Sep","september","degrees Celsius","*degree*C*", +"temperature_max_10","temperature_max_10","WorldClim_2.1_ACCESS-CM2_ssp245_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Oct","max T Oct","october","degrees Celsius","*degree*C*", +"temperature_max_11","temperature_max_11","WorldClim_2.1_ACCESS-CM2_ssp245_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Nov","max T Nov","november","degrees Celsius","*degree*C*", +"temperature_max_12","temperature_max_12","WorldClim_2.1_ACCESS-CM2_ssp245_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Dec","max T Dec","december","degrees Celsius","*degree*C*", +"bio01","bio01","WorldClim_2.1_ACCESS-CM2_ssp370_10m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual mean temperature","ann. mean T","year","degrees Celsius","*degree*C*", +"bio02","bio02","WorldClim_2.1_ACCESS-CM2_ssp370_10m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean diurnal range","diurn. range","year","degrees Celsius","*degree*C*", +"bio03","bio03","WorldClim_2.1_ACCESS-CM2_ssp370_10m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","isothermality","isothermality","year","","", +"bio04","bio04","WorldClim_2.1_ACCESS-CM2_ssp370_10m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature seasonality","T season.","year","degrees Celsius","*degree*C*", +"bio05","bio05","WorldClim_2.1_ACCESS-CM2_ssp370_10m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature of warmest month","max. T of warmest mo.","year","degrees Celsius","*degree*C*", +"bio06","bio06","WorldClim_2.1_ACCESS-CM2_ssp370_10m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature of coldest month","min. T of coldest mo.","year","degrees Celsius","*degree*C*", +"bio07","bio07","WorldClim_2.1_ACCESS-CM2_ssp370_10m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature annual range (bio05-bio06)","T ann. Range","year","degrees Celsius","*degree*C*", +"bio08","bio08","WorldClim_2.1_ACCESS-CM2_ssp370_10m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of wettest quarter","mean T of wettest qtr","year","degrees Celsius","*degree*C*", +"bio09","bio09","WorldClim_2.1_ACCESS-CM2_ssp370_10m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of driest quarter","mean T of driest qtr","year","degrees Celsius","*degree*C*", +"bio10","bio10","WorldClim_2.1_ACCESS-CM2_ssp370_10m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of warmest quarter","mean T of warmest qtr","year","degrees Celsius","*degree*C*", +"bio11","bio11","WorldClim_2.1_ACCESS-CM2_ssp370_10m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of coldest quarter","mean T of coldest qtr","year","degrees Celsius","*degree*C*", +"bio12","bio12","WorldClim_2.1_ACCESS-CM2_ssp370_10m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual precipitation","ann. P","year","mm per year","*mm~yr^-1*", +"bio13","bio13","WorldClim_2.1_ACCESS-CM2_ssp370_10m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest month","P of wettest mo.","year","mm per month","*mm~mo^-1*", +"bio14","bio14","WorldClim_2.1_ACCESS-CM2_ssp370_10m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest month","P of driest mo.","year","mm per month","*mm~mo^-1*", +"bio15","bio15","WorldClim_2.1_ACCESS-CM2_ssp370_10m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation seasonality (coeff var)","P season.","year","","", +"bio16","bio16","WorldClim_2.1_ACCESS-CM2_ssp370_10m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest quarter","P of wettest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio17","bio17","WorldClim_2.1_ACCESS-CM2_ssp370_10m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest quarter","P of driest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio18","bio18","WorldClim_2.1_ACCESS-CM2_ssp370_10m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of warmest quarter","P of warmest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio19","bio19","WorldClim_2.1_ACCESS-CM2_ssp370_10m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of coldest quarter","P of coldest qtr","year","mm per quarter","*mm~qtr^-1*", +"precipitation_01","precipitation_01","WorldClim_2.1_ACCESS-CM2_ssp370_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jan","P Jan","january","mm per month","*mm~mo^-1*", +"precipitation_02","precipitation_02","WorldClim_2.1_ACCESS-CM2_ssp370_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Feb","P Feb","february","mm per month","*mm~mo^-1*", +"precipitation_03","precipitation_03","WorldClim_2.1_ACCESS-CM2_ssp370_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Mar","P Mar","march","mm per month","*mm~mo^-1*", +"precipitation_04","precipitation_04","WorldClim_2.1_ACCESS-CM2_ssp370_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Apr","P Apr","april","mm per month","*mm~mo^-1*", +"precipitation_05","precipitation_05","WorldClim_2.1_ACCESS-CM2_ssp370_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation May","P May","may","mm per month","*mm~mo^-1*", +"precipitation_06","precipitation_06","WorldClim_2.1_ACCESS-CM2_ssp370_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jun","P Jun","june","mm per month","*mm~mo^-1*", +"precipitation_07","precipitation_07","WorldClim_2.1_ACCESS-CM2_ssp370_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jul","P Jul","july","mm per month","*mm~mo^-1*", +"precipitation_08","precipitation_08","WorldClim_2.1_ACCESS-CM2_ssp370_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Aug","P Aug","august","mm per month","*mm~mo^-1*", +"precipitation_09","precipitation_09","WorldClim_2.1_ACCESS-CM2_ssp370_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Sep","P Sep","september","mm per month","*mm~mo^-1*", +"precipitation_10","precipitation_10","WorldClim_2.1_ACCESS-CM2_ssp370_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Oct","P Oct","october","mm per month","*mm~mo^-1*", +"precipitation_11","precipitation_11","WorldClim_2.1_ACCESS-CM2_ssp370_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Nov","P Nov","november","mm per month","*mm~mo^-1*", +"precipitation_12","precipitation_12","WorldClim_2.1_ACCESS-CM2_ssp370_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Dec","P Dec","december","mm per month","*mm~mo^-1*", +"temperature_min_01","temperature_min_01","WorldClim_2.1_ACCESS-CM2_ssp370_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jan","min T Jan","january","degrees Celsius","*degree*C*", +"temperature_min_02","temperature_min_02","WorldClim_2.1_ACCESS-CM2_ssp370_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Feb","min T Feb","february","degrees Celsius","*degree*C*", +"temperature_min_03","temperature_min_03","WorldClim_2.1_ACCESS-CM2_ssp370_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Mar","min T Mar","march","degrees Celsius","*degree*C*", +"temperature_min_04","temperature_min_04","WorldClim_2.1_ACCESS-CM2_ssp370_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Apr","min T Apr","april","degrees Celsius","*degree*C*", +"temperature_min_05","temperature_min_05","WorldClim_2.1_ACCESS-CM2_ssp370_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature May","min T May","may","degrees Celsius","*degree*C*", +"temperature_min_06","temperature_min_06","WorldClim_2.1_ACCESS-CM2_ssp370_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jun","min T Jun","june","degrees Celsius","*degree*C*", +"temperature_min_07","temperature_min_07","WorldClim_2.1_ACCESS-CM2_ssp370_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jul","min T Jul","july","degrees Celsius","*degree*C*", +"temperature_min_08","temperature_min_08","WorldClim_2.1_ACCESS-CM2_ssp370_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Aug","min T Aug","august","degrees Celsius","*degree*C*", +"temperature_min_09","temperature_min_09","WorldClim_2.1_ACCESS-CM2_ssp370_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Sep","min T Sep","september","degrees Celsius","*degree*C*", +"temperature_min_10","temperature_min_10","WorldClim_2.1_ACCESS-CM2_ssp370_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Oct","min T Oct","october","degrees Celsius","*degree*C*", +"temperature_min_11","temperature_min_11","WorldClim_2.1_ACCESS-CM2_ssp370_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Nov","min T Nov","november","degrees Celsius","*degree*C*", +"temperature_min_12","temperature_min_12","WorldClim_2.1_ACCESS-CM2_ssp370_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Dec","min T Dec","december","degrees Celsius","*degree*C*", +"temperature_max_01","temperature_max_01","WorldClim_2.1_ACCESS-CM2_ssp370_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jan","max T Jan","january","degrees Celsius","*degree*C*", +"temperature_max_02","temperature_max_02","WorldClim_2.1_ACCESS-CM2_ssp370_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Feb","max T Feb","february","degrees Celsius","*degree*C*", +"temperature_max_03","temperature_max_03","WorldClim_2.1_ACCESS-CM2_ssp370_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Mar","max T Mar","march","degrees Celsius","*degree*C*", +"temperature_max_04","temperature_max_04","WorldClim_2.1_ACCESS-CM2_ssp370_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Apr","max T Apr","april","degrees Celsius","*degree*C*", +"temperature_max_05","temperature_max_05","WorldClim_2.1_ACCESS-CM2_ssp370_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature May","max T May","may","degrees Celsius","*degree*C*", +"temperature_max_06","temperature_max_06","WorldClim_2.1_ACCESS-CM2_ssp370_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jun","max T Jun","june","degrees Celsius","*degree*C*", +"temperature_max_07","temperature_max_07","WorldClim_2.1_ACCESS-CM2_ssp370_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jul","max T Jul","july","degrees Celsius","*degree*C*", +"temperature_max_08","temperature_max_08","WorldClim_2.1_ACCESS-CM2_ssp370_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Aug","max T Aug","august","degrees Celsius","*degree*C*", +"temperature_max_09","temperature_max_09","WorldClim_2.1_ACCESS-CM2_ssp370_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Sep","max T Sep","september","degrees Celsius","*degree*C*", +"temperature_max_10","temperature_max_10","WorldClim_2.1_ACCESS-CM2_ssp370_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Oct","max T Oct","october","degrees Celsius","*degree*C*", +"temperature_max_11","temperature_max_11","WorldClim_2.1_ACCESS-CM2_ssp370_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Nov","max T Nov","november","degrees Celsius","*degree*C*", +"temperature_max_12","temperature_max_12","WorldClim_2.1_ACCESS-CM2_ssp370_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Dec","max T Dec","december","degrees Celsius","*degree*C*", +"bio01","bio01","WorldClim_2.1_ACCESS-CM2_ssp370_5m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual mean temperature","ann. mean T","year","degrees Celsius","*degree*C*", +"bio02","bio02","WorldClim_2.1_ACCESS-CM2_ssp370_5m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean diurnal range","diurn. range","year","degrees Celsius","*degree*C*", +"bio03","bio03","WorldClim_2.1_ACCESS-CM2_ssp370_5m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","isothermality","isothermality","year","","", +"bio04","bio04","WorldClim_2.1_ACCESS-CM2_ssp370_5m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature seasonality","T season.","year","degrees Celsius","*degree*C*", +"bio05","bio05","WorldClim_2.1_ACCESS-CM2_ssp370_5m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature of warmest month","max. T of warmest mo.","year","degrees Celsius","*degree*C*", +"bio06","bio06","WorldClim_2.1_ACCESS-CM2_ssp370_5m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature of coldest month","min. T of coldest mo.","year","degrees Celsius","*degree*C*", +"bio07","bio07","WorldClim_2.1_ACCESS-CM2_ssp370_5m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature annual range (bio05-bio06)","T ann. Range","year","degrees Celsius","*degree*C*", +"bio08","bio08","WorldClim_2.1_ACCESS-CM2_ssp370_5m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of wettest quarter","mean T of wettest qtr","year","degrees Celsius","*degree*C*", +"bio09","bio09","WorldClim_2.1_ACCESS-CM2_ssp370_5m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of driest quarter","mean T of driest qtr","year","degrees Celsius","*degree*C*", +"bio10","bio10","WorldClim_2.1_ACCESS-CM2_ssp370_5m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of warmest quarter","mean T of warmest qtr","year","degrees Celsius","*degree*C*", +"bio11","bio11","WorldClim_2.1_ACCESS-CM2_ssp370_5m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of coldest quarter","mean T of coldest qtr","year","degrees Celsius","*degree*C*", +"bio12","bio12","WorldClim_2.1_ACCESS-CM2_ssp370_5m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual precipitation","ann. P","year","mm per year","*mm~yr^-1*", +"bio13","bio13","WorldClim_2.1_ACCESS-CM2_ssp370_5m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest month","P of wettest mo.","year","mm per month","*mm~mo^-1*", +"bio14","bio14","WorldClim_2.1_ACCESS-CM2_ssp370_5m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest month","P of driest mo.","year","mm per month","*mm~mo^-1*", +"bio15","bio15","WorldClim_2.1_ACCESS-CM2_ssp370_5m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation seasonality (coeff var)","P season.","year","","", +"bio16","bio16","WorldClim_2.1_ACCESS-CM2_ssp370_5m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest quarter","P of wettest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio17","bio17","WorldClim_2.1_ACCESS-CM2_ssp370_5m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest quarter","P of driest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio18","bio18","WorldClim_2.1_ACCESS-CM2_ssp370_5m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of warmest quarter","P of warmest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio19","bio19","WorldClim_2.1_ACCESS-CM2_ssp370_5m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of coldest quarter","P of coldest qtr","year","mm per quarter","*mm~qtr^-1*", +"precipitation_01","precipitation_01","WorldClim_2.1_ACCESS-CM2_ssp370_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jan","P Jan","january","mm per month","*mm~mo^-1*", +"precipitation_02","precipitation_02","WorldClim_2.1_ACCESS-CM2_ssp370_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Feb","P Feb","february","mm per month","*mm~mo^-1*", +"precipitation_03","precipitation_03","WorldClim_2.1_ACCESS-CM2_ssp370_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Mar","P Mar","march","mm per month","*mm~mo^-1*", +"precipitation_04","precipitation_04","WorldClim_2.1_ACCESS-CM2_ssp370_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Apr","P Apr","april","mm per month","*mm~mo^-1*", +"precipitation_05","precipitation_05","WorldClim_2.1_ACCESS-CM2_ssp370_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation May","P May","may","mm per month","*mm~mo^-1*", +"precipitation_06","precipitation_06","WorldClim_2.1_ACCESS-CM2_ssp370_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jun","P Jun","june","mm per month","*mm~mo^-1*", +"precipitation_07","precipitation_07","WorldClim_2.1_ACCESS-CM2_ssp370_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jul","P Jul","july","mm per month","*mm~mo^-1*", +"precipitation_08","precipitation_08","WorldClim_2.1_ACCESS-CM2_ssp370_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Aug","P Aug","august","mm per month","*mm~mo^-1*", +"precipitation_09","precipitation_09","WorldClim_2.1_ACCESS-CM2_ssp370_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Sep","P Sep","september","mm per month","*mm~mo^-1*", +"precipitation_10","precipitation_10","WorldClim_2.1_ACCESS-CM2_ssp370_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Oct","P Oct","october","mm per month","*mm~mo^-1*", +"precipitation_11","precipitation_11","WorldClim_2.1_ACCESS-CM2_ssp370_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Nov","P Nov","november","mm per month","*mm~mo^-1*", +"precipitation_12","precipitation_12","WorldClim_2.1_ACCESS-CM2_ssp370_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Dec","P Dec","december","mm per month","*mm~mo^-1*", +"temperature_min_01","temperature_min_01","WorldClim_2.1_ACCESS-CM2_ssp370_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jan","min T Jan","january","degrees Celsius","*degree*C*", +"temperature_min_02","temperature_min_02","WorldClim_2.1_ACCESS-CM2_ssp370_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Feb","min T Feb","february","degrees Celsius","*degree*C*", +"temperature_min_03","temperature_min_03","WorldClim_2.1_ACCESS-CM2_ssp370_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Mar","min T Mar","march","degrees Celsius","*degree*C*", +"temperature_min_04","temperature_min_04","WorldClim_2.1_ACCESS-CM2_ssp370_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Apr","min T Apr","april","degrees Celsius","*degree*C*", +"temperature_min_05","temperature_min_05","WorldClim_2.1_ACCESS-CM2_ssp370_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature May","min T May","may","degrees Celsius","*degree*C*", +"temperature_min_06","temperature_min_06","WorldClim_2.1_ACCESS-CM2_ssp370_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jun","min T Jun","june","degrees Celsius","*degree*C*", +"temperature_min_07","temperature_min_07","WorldClim_2.1_ACCESS-CM2_ssp370_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jul","min T Jul","july","degrees Celsius","*degree*C*", +"temperature_min_08","temperature_min_08","WorldClim_2.1_ACCESS-CM2_ssp370_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Aug","min T Aug","august","degrees Celsius","*degree*C*", +"temperature_min_09","temperature_min_09","WorldClim_2.1_ACCESS-CM2_ssp370_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Sep","min T Sep","september","degrees Celsius","*degree*C*", +"temperature_min_10","temperature_min_10","WorldClim_2.1_ACCESS-CM2_ssp370_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Oct","min T Oct","october","degrees Celsius","*degree*C*", +"temperature_min_11","temperature_min_11","WorldClim_2.1_ACCESS-CM2_ssp370_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Nov","min T Nov","november","degrees Celsius","*degree*C*", +"temperature_min_12","temperature_min_12","WorldClim_2.1_ACCESS-CM2_ssp370_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Dec","min T Dec","december","degrees Celsius","*degree*C*", +"temperature_max_01","temperature_max_01","WorldClim_2.1_ACCESS-CM2_ssp370_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jan","max T Jan","january","degrees Celsius","*degree*C*", +"temperature_max_02","temperature_max_02","WorldClim_2.1_ACCESS-CM2_ssp370_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Feb","max T Feb","february","degrees Celsius","*degree*C*", +"temperature_max_03","temperature_max_03","WorldClim_2.1_ACCESS-CM2_ssp370_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Mar","max T Mar","march","degrees Celsius","*degree*C*", +"temperature_max_04","temperature_max_04","WorldClim_2.1_ACCESS-CM2_ssp370_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Apr","max T Apr","april","degrees Celsius","*degree*C*", +"temperature_max_05","temperature_max_05","WorldClim_2.1_ACCESS-CM2_ssp370_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature May","max T May","may","degrees Celsius","*degree*C*", +"temperature_max_06","temperature_max_06","WorldClim_2.1_ACCESS-CM2_ssp370_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jun","max T Jun","june","degrees Celsius","*degree*C*", +"temperature_max_07","temperature_max_07","WorldClim_2.1_ACCESS-CM2_ssp370_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jul","max T Jul","july","degrees Celsius","*degree*C*", +"temperature_max_08","temperature_max_08","WorldClim_2.1_ACCESS-CM2_ssp370_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Aug","max T Aug","august","degrees Celsius","*degree*C*", +"temperature_max_09","temperature_max_09","WorldClim_2.1_ACCESS-CM2_ssp370_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Sep","max T Sep","september","degrees Celsius","*degree*C*", +"temperature_max_10","temperature_max_10","WorldClim_2.1_ACCESS-CM2_ssp370_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Oct","max T Oct","october","degrees Celsius","*degree*C*", +"temperature_max_11","temperature_max_11","WorldClim_2.1_ACCESS-CM2_ssp370_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Nov","max T Nov","november","degrees Celsius","*degree*C*", +"temperature_max_12","temperature_max_12","WorldClim_2.1_ACCESS-CM2_ssp370_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Dec","max T Dec","december","degrees Celsius","*degree*C*", +"bio01","bio01","WorldClim_2.1_ACCESS-CM2_ssp585_10m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual mean temperature","ann. mean T","year","degrees Celsius","*degree*C*", +"bio02","bio02","WorldClim_2.1_ACCESS-CM2_ssp585_10m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean diurnal range","diurn. range","year","degrees Celsius","*degree*C*", +"bio03","bio03","WorldClim_2.1_ACCESS-CM2_ssp585_10m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","isothermality","isothermality","year","","", +"bio04","bio04","WorldClim_2.1_ACCESS-CM2_ssp585_10m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature seasonality","T season.","year","degrees Celsius","*degree*C*", +"bio05","bio05","WorldClim_2.1_ACCESS-CM2_ssp585_10m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature of warmest month","max. T of warmest mo.","year","degrees Celsius","*degree*C*", +"bio06","bio06","WorldClim_2.1_ACCESS-CM2_ssp585_10m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature of coldest month","min. T of coldest mo.","year","degrees Celsius","*degree*C*", +"bio07","bio07","WorldClim_2.1_ACCESS-CM2_ssp585_10m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature annual range (bio05-bio06)","T ann. Range","year","degrees Celsius","*degree*C*", +"bio08","bio08","WorldClim_2.1_ACCESS-CM2_ssp585_10m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of wettest quarter","mean T of wettest qtr","year","degrees Celsius","*degree*C*", +"bio09","bio09","WorldClim_2.1_ACCESS-CM2_ssp585_10m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of driest quarter","mean T of driest qtr","year","degrees Celsius","*degree*C*", +"bio10","bio10","WorldClim_2.1_ACCESS-CM2_ssp585_10m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of warmest quarter","mean T of warmest qtr","year","degrees Celsius","*degree*C*", +"bio11","bio11","WorldClim_2.1_ACCESS-CM2_ssp585_10m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of coldest quarter","mean T of coldest qtr","year","degrees Celsius","*degree*C*", +"bio12","bio12","WorldClim_2.1_ACCESS-CM2_ssp585_10m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual precipitation","ann. P","year","mm per year","*mm~yr^-1*", +"bio13","bio13","WorldClim_2.1_ACCESS-CM2_ssp585_10m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest month","P of wettest mo.","year","mm per month","*mm~mo^-1*", +"bio14","bio14","WorldClim_2.1_ACCESS-CM2_ssp585_10m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest month","P of driest mo.","year","mm per month","*mm~mo^-1*", +"bio15","bio15","WorldClim_2.1_ACCESS-CM2_ssp585_10m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation seasonality (coeff var)","P season.","year","","", +"bio16","bio16","WorldClim_2.1_ACCESS-CM2_ssp585_10m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest quarter","P of wettest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio17","bio17","WorldClim_2.1_ACCESS-CM2_ssp585_10m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest quarter","P of driest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio18","bio18","WorldClim_2.1_ACCESS-CM2_ssp585_10m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of warmest quarter","P of warmest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio19","bio19","WorldClim_2.1_ACCESS-CM2_ssp585_10m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of coldest quarter","P of coldest qtr","year","mm per quarter","*mm~qtr^-1*", +"precipitation_01","precipitation_01","WorldClim_2.1_ACCESS-CM2_ssp585_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jan","P Jan","january","mm per month","*mm~mo^-1*", +"precipitation_02","precipitation_02","WorldClim_2.1_ACCESS-CM2_ssp585_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Feb","P Feb","february","mm per month","*mm~mo^-1*", +"precipitation_03","precipitation_03","WorldClim_2.1_ACCESS-CM2_ssp585_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Mar","P Mar","march","mm per month","*mm~mo^-1*", +"precipitation_04","precipitation_04","WorldClim_2.1_ACCESS-CM2_ssp585_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Apr","P Apr","april","mm per month","*mm~mo^-1*", +"precipitation_05","precipitation_05","WorldClim_2.1_ACCESS-CM2_ssp585_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation May","P May","may","mm per month","*mm~mo^-1*", +"precipitation_06","precipitation_06","WorldClim_2.1_ACCESS-CM2_ssp585_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jun","P Jun","june","mm per month","*mm~mo^-1*", +"precipitation_07","precipitation_07","WorldClim_2.1_ACCESS-CM2_ssp585_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jul","P Jul","july","mm per month","*mm~mo^-1*", +"precipitation_08","precipitation_08","WorldClim_2.1_ACCESS-CM2_ssp585_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Aug","P Aug","august","mm per month","*mm~mo^-1*", +"precipitation_09","precipitation_09","WorldClim_2.1_ACCESS-CM2_ssp585_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Sep","P Sep","september","mm per month","*mm~mo^-1*", +"precipitation_10","precipitation_10","WorldClim_2.1_ACCESS-CM2_ssp585_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Oct","P Oct","october","mm per month","*mm~mo^-1*", +"precipitation_11","precipitation_11","WorldClim_2.1_ACCESS-CM2_ssp585_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Nov","P Nov","november","mm per month","*mm~mo^-1*", +"precipitation_12","precipitation_12","WorldClim_2.1_ACCESS-CM2_ssp585_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Dec","P Dec","december","mm per month","*mm~mo^-1*", +"temperature_min_01","temperature_min_01","WorldClim_2.1_ACCESS-CM2_ssp585_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jan","min T Jan","january","degrees Celsius","*degree*C*", +"temperature_min_02","temperature_min_02","WorldClim_2.1_ACCESS-CM2_ssp585_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Feb","min T Feb","february","degrees Celsius","*degree*C*", +"temperature_min_03","temperature_min_03","WorldClim_2.1_ACCESS-CM2_ssp585_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Mar","min T Mar","march","degrees Celsius","*degree*C*", +"temperature_min_04","temperature_min_04","WorldClim_2.1_ACCESS-CM2_ssp585_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Apr","min T Apr","april","degrees Celsius","*degree*C*", +"temperature_min_05","temperature_min_05","WorldClim_2.1_ACCESS-CM2_ssp585_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature May","min T May","may","degrees Celsius","*degree*C*", +"temperature_min_06","temperature_min_06","WorldClim_2.1_ACCESS-CM2_ssp585_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jun","min T Jun","june","degrees Celsius","*degree*C*", +"temperature_min_07","temperature_min_07","WorldClim_2.1_ACCESS-CM2_ssp585_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jul","min T Jul","july","degrees Celsius","*degree*C*", +"temperature_min_08","temperature_min_08","WorldClim_2.1_ACCESS-CM2_ssp585_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Aug","min T Aug","august","degrees Celsius","*degree*C*", +"temperature_min_09","temperature_min_09","WorldClim_2.1_ACCESS-CM2_ssp585_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Sep","min T Sep","september","degrees Celsius","*degree*C*", +"temperature_min_10","temperature_min_10","WorldClim_2.1_ACCESS-CM2_ssp585_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Oct","min T Oct","october","degrees Celsius","*degree*C*", +"temperature_min_11","temperature_min_11","WorldClim_2.1_ACCESS-CM2_ssp585_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Nov","min T Nov","november","degrees Celsius","*degree*C*", +"temperature_min_12","temperature_min_12","WorldClim_2.1_ACCESS-CM2_ssp585_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Dec","min T Dec","december","degrees Celsius","*degree*C*", +"temperature_max_01","temperature_max_01","WorldClim_2.1_ACCESS-CM2_ssp585_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jan","max T Jan","january","degrees Celsius","*degree*C*", +"temperature_max_02","temperature_max_02","WorldClim_2.1_ACCESS-CM2_ssp585_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Feb","max T Feb","february","degrees Celsius","*degree*C*", +"temperature_max_03","temperature_max_03","WorldClim_2.1_ACCESS-CM2_ssp585_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Mar","max T Mar","march","degrees Celsius","*degree*C*", +"temperature_max_04","temperature_max_04","WorldClim_2.1_ACCESS-CM2_ssp585_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Apr","max T Apr","april","degrees Celsius","*degree*C*", +"temperature_max_05","temperature_max_05","WorldClim_2.1_ACCESS-CM2_ssp585_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature May","max T May","may","degrees Celsius","*degree*C*", +"temperature_max_06","temperature_max_06","WorldClim_2.1_ACCESS-CM2_ssp585_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jun","max T Jun","june","degrees Celsius","*degree*C*", +"temperature_max_07","temperature_max_07","WorldClim_2.1_ACCESS-CM2_ssp585_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jul","max T Jul","july","degrees Celsius","*degree*C*", +"temperature_max_08","temperature_max_08","WorldClim_2.1_ACCESS-CM2_ssp585_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Aug","max T Aug","august","degrees Celsius","*degree*C*", +"temperature_max_09","temperature_max_09","WorldClim_2.1_ACCESS-CM2_ssp585_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Sep","max T Sep","september","degrees Celsius","*degree*C*", +"temperature_max_10","temperature_max_10","WorldClim_2.1_ACCESS-CM2_ssp585_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Oct","max T Oct","october","degrees Celsius","*degree*C*", +"temperature_max_11","temperature_max_11","WorldClim_2.1_ACCESS-CM2_ssp585_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Nov","max T Nov","november","degrees Celsius","*degree*C*", +"temperature_max_12","temperature_max_12","WorldClim_2.1_ACCESS-CM2_ssp585_10m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Dec","max T Dec","december","degrees Celsius","*degree*C*", +"bio01","bio01","WorldClim_2.1_ACCESS-CM2_ssp585_5m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual mean temperature","ann. mean T","year","degrees Celsius","*degree*C*", +"bio02","bio02","WorldClim_2.1_ACCESS-CM2_ssp585_5m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean diurnal range","diurn. range","year","degrees Celsius","*degree*C*", +"bio03","bio03","WorldClim_2.1_ACCESS-CM2_ssp585_5m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","isothermality","isothermality","year","","", +"bio04","bio04","WorldClim_2.1_ACCESS-CM2_ssp585_5m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature seasonality","T season.","year","degrees Celsius","*degree*C*", +"bio05","bio05","WorldClim_2.1_ACCESS-CM2_ssp585_5m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature of warmest month","max. T of warmest mo.","year","degrees Celsius","*degree*C*", +"bio06","bio06","WorldClim_2.1_ACCESS-CM2_ssp585_5m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature of coldest month","min. T of coldest mo.","year","degrees Celsius","*degree*C*", +"bio07","bio07","WorldClim_2.1_ACCESS-CM2_ssp585_5m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature annual range (bio05-bio06)","T ann. Range","year","degrees Celsius","*degree*C*", +"bio08","bio08","WorldClim_2.1_ACCESS-CM2_ssp585_5m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of wettest quarter","mean T of wettest qtr","year","degrees Celsius","*degree*C*", +"bio09","bio09","WorldClim_2.1_ACCESS-CM2_ssp585_5m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of driest quarter","mean T of driest qtr","year","degrees Celsius","*degree*C*", +"bio10","bio10","WorldClim_2.1_ACCESS-CM2_ssp585_5m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of warmest quarter","mean T of warmest qtr","year","degrees Celsius","*degree*C*", +"bio11","bio11","WorldClim_2.1_ACCESS-CM2_ssp585_5m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of coldest quarter","mean T of coldest qtr","year","degrees Celsius","*degree*C*", +"bio12","bio12","WorldClim_2.1_ACCESS-CM2_ssp585_5m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual precipitation","ann. P","year","mm per year","*mm~yr^-1*", +"bio13","bio13","WorldClim_2.1_ACCESS-CM2_ssp585_5m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest month","P of wettest mo.","year","mm per month","*mm~mo^-1*", +"bio14","bio14","WorldClim_2.1_ACCESS-CM2_ssp585_5m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest month","P of driest mo.","year","mm per month","*mm~mo^-1*", +"bio15","bio15","WorldClim_2.1_ACCESS-CM2_ssp585_5m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation seasonality (coeff var)","P season.","year","","", +"bio16","bio16","WorldClim_2.1_ACCESS-CM2_ssp585_5m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest quarter","P of wettest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio17","bio17","WorldClim_2.1_ACCESS-CM2_ssp585_5m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest quarter","P of driest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio18","bio18","WorldClim_2.1_ACCESS-CM2_ssp585_5m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of warmest quarter","P of warmest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio19","bio19","WorldClim_2.1_ACCESS-CM2_ssp585_5m",FALSE,"WorldClim_2.1_ACCESS-CM2_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of coldest quarter","P of coldest qtr","year","mm per quarter","*mm~qtr^-1*", +"precipitation_01","precipitation_01","WorldClim_2.1_ACCESS-CM2_ssp585_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jan","P Jan","january","mm per month","*mm~mo^-1*", +"precipitation_02","precipitation_02","WorldClim_2.1_ACCESS-CM2_ssp585_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Feb","P Feb","february","mm per month","*mm~mo^-1*", +"precipitation_03","precipitation_03","WorldClim_2.1_ACCESS-CM2_ssp585_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Mar","P Mar","march","mm per month","*mm~mo^-1*", +"precipitation_04","precipitation_04","WorldClim_2.1_ACCESS-CM2_ssp585_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Apr","P Apr","april","mm per month","*mm~mo^-1*", +"precipitation_05","precipitation_05","WorldClim_2.1_ACCESS-CM2_ssp585_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation May","P May","may","mm per month","*mm~mo^-1*", +"precipitation_06","precipitation_06","WorldClim_2.1_ACCESS-CM2_ssp585_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jun","P Jun","june","mm per month","*mm~mo^-1*", +"precipitation_07","precipitation_07","WorldClim_2.1_ACCESS-CM2_ssp585_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jul","P Jul","july","mm per month","*mm~mo^-1*", +"precipitation_08","precipitation_08","WorldClim_2.1_ACCESS-CM2_ssp585_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Aug","P Aug","august","mm per month","*mm~mo^-1*", +"precipitation_09","precipitation_09","WorldClim_2.1_ACCESS-CM2_ssp585_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Sep","P Sep","september","mm per month","*mm~mo^-1*", +"precipitation_10","precipitation_10","WorldClim_2.1_ACCESS-CM2_ssp585_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Oct","P Oct","october","mm per month","*mm~mo^-1*", +"precipitation_11","precipitation_11","WorldClim_2.1_ACCESS-CM2_ssp585_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Nov","P Nov","november","mm per month","*mm~mo^-1*", +"precipitation_12","precipitation_12","WorldClim_2.1_ACCESS-CM2_ssp585_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Dec","P Dec","december","mm per month","*mm~mo^-1*", +"temperature_min_01","temperature_min_01","WorldClim_2.1_ACCESS-CM2_ssp585_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jan","min T Jan","january","degrees Celsius","*degree*C*", +"temperature_min_02","temperature_min_02","WorldClim_2.1_ACCESS-CM2_ssp585_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Feb","min T Feb","february","degrees Celsius","*degree*C*", +"temperature_min_03","temperature_min_03","WorldClim_2.1_ACCESS-CM2_ssp585_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Mar","min T Mar","march","degrees Celsius","*degree*C*", +"temperature_min_04","temperature_min_04","WorldClim_2.1_ACCESS-CM2_ssp585_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Apr","min T Apr","april","degrees Celsius","*degree*C*", +"temperature_min_05","temperature_min_05","WorldClim_2.1_ACCESS-CM2_ssp585_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature May","min T May","may","degrees Celsius","*degree*C*", +"temperature_min_06","temperature_min_06","WorldClim_2.1_ACCESS-CM2_ssp585_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jun","min T Jun","june","degrees Celsius","*degree*C*", +"temperature_min_07","temperature_min_07","WorldClim_2.1_ACCESS-CM2_ssp585_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jul","min T Jul","july","degrees Celsius","*degree*C*", +"temperature_min_08","temperature_min_08","WorldClim_2.1_ACCESS-CM2_ssp585_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Aug","min T Aug","august","degrees Celsius","*degree*C*", +"temperature_min_09","temperature_min_09","WorldClim_2.1_ACCESS-CM2_ssp585_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Sep","min T Sep","september","degrees Celsius","*degree*C*", +"temperature_min_10","temperature_min_10","WorldClim_2.1_ACCESS-CM2_ssp585_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Oct","min T Oct","october","degrees Celsius","*degree*C*", +"temperature_min_11","temperature_min_11","WorldClim_2.1_ACCESS-CM2_ssp585_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Nov","min T Nov","november","degrees Celsius","*degree*C*", +"temperature_min_12","temperature_min_12","WorldClim_2.1_ACCESS-CM2_ssp585_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Dec","min T Dec","december","degrees Celsius","*degree*C*", +"temperature_max_01","temperature_max_01","WorldClim_2.1_ACCESS-CM2_ssp585_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jan","max T Jan","january","degrees Celsius","*degree*C*", +"temperature_max_02","temperature_max_02","WorldClim_2.1_ACCESS-CM2_ssp585_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Feb","max T Feb","february","degrees Celsius","*degree*C*", +"temperature_max_03","temperature_max_03","WorldClim_2.1_ACCESS-CM2_ssp585_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Mar","max T Mar","march","degrees Celsius","*degree*C*", +"temperature_max_04","temperature_max_04","WorldClim_2.1_ACCESS-CM2_ssp585_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Apr","max T Apr","april","degrees Celsius","*degree*C*", +"temperature_max_05","temperature_max_05","WorldClim_2.1_ACCESS-CM2_ssp585_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature May","max T May","may","degrees Celsius","*degree*C*", +"temperature_max_06","temperature_max_06","WorldClim_2.1_ACCESS-CM2_ssp585_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jun","max T Jun","june","degrees Celsius","*degree*C*", +"temperature_max_07","temperature_max_07","WorldClim_2.1_ACCESS-CM2_ssp585_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jul","max T Jul","july","degrees Celsius","*degree*C*", +"temperature_max_08","temperature_max_08","WorldClim_2.1_ACCESS-CM2_ssp585_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Aug","max T Aug","august","degrees Celsius","*degree*C*", +"temperature_max_09","temperature_max_09","WorldClim_2.1_ACCESS-CM2_ssp585_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Sep","max T Sep","september","degrees Celsius","*degree*C*", +"temperature_max_10","temperature_max_10","WorldClim_2.1_ACCESS-CM2_ssp585_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Oct","max T Oct","october","degrees Celsius","*degree*C*", +"temperature_max_11","temperature_max_11","WorldClim_2.1_ACCESS-CM2_ssp585_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Nov","max T Nov","november","degrees Celsius","*degree*C*", +"temperature_max_12","temperature_max_12","WorldClim_2.1_ACCESS-CM2_ssp585_5m",TRUE,"WorldClim_2.1_ACCESS-CM2_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Dec","max T Dec","december","degrees Celsius","*degree*C*", +"bio01","bio01","WorldClim_2.1_BCC-CSM2-MR_ssp126_10m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual mean temperature","ann. mean T","year","degrees Celsius","*degree*C*", +"bio02","bio02","WorldClim_2.1_BCC-CSM2-MR_ssp126_10m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean diurnal range","diurn. range","year","degrees Celsius","*degree*C*", +"bio03","bio03","WorldClim_2.1_BCC-CSM2-MR_ssp126_10m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","isothermality","isothermality","year","","", +"bio04","bio04","WorldClim_2.1_BCC-CSM2-MR_ssp126_10m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature seasonality","T season.","year","degrees Celsius","*degree*C*", +"bio05","bio05","WorldClim_2.1_BCC-CSM2-MR_ssp126_10m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature of warmest month","max. T of warmest mo.","year","degrees Celsius","*degree*C*", +"bio06","bio06","WorldClim_2.1_BCC-CSM2-MR_ssp126_10m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature of coldest month","min. T of coldest mo.","year","degrees Celsius","*degree*C*", +"bio07","bio07","WorldClim_2.1_BCC-CSM2-MR_ssp126_10m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature annual range (bio05-bio06)","T ann. Range","year","degrees Celsius","*degree*C*", +"bio08","bio08","WorldClim_2.1_BCC-CSM2-MR_ssp126_10m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of wettest quarter","mean T of wettest qtr","year","degrees Celsius","*degree*C*", +"bio09","bio09","WorldClim_2.1_BCC-CSM2-MR_ssp126_10m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of driest quarter","mean T of driest qtr","year","degrees Celsius","*degree*C*", +"bio10","bio10","WorldClim_2.1_BCC-CSM2-MR_ssp126_10m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of warmest quarter","mean T of warmest qtr","year","degrees Celsius","*degree*C*", +"bio11","bio11","WorldClim_2.1_BCC-CSM2-MR_ssp126_10m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of coldest quarter","mean T of coldest qtr","year","degrees Celsius","*degree*C*", +"bio12","bio12","WorldClim_2.1_BCC-CSM2-MR_ssp126_10m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual precipitation","ann. P","year","mm per year","*mm~yr^-1*", +"bio13","bio13","WorldClim_2.1_BCC-CSM2-MR_ssp126_10m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest month","P of wettest mo.","year","mm per month","*mm~mo^-1*", +"bio14","bio14","WorldClim_2.1_BCC-CSM2-MR_ssp126_10m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest month","P of driest mo.","year","mm per month","*mm~mo^-1*", +"bio15","bio15","WorldClim_2.1_BCC-CSM2-MR_ssp126_10m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation seasonality (coeff var)","P season.","year","","", +"bio16","bio16","WorldClim_2.1_BCC-CSM2-MR_ssp126_10m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest quarter","P of wettest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio17","bio17","WorldClim_2.1_BCC-CSM2-MR_ssp126_10m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest quarter","P of driest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio18","bio18","WorldClim_2.1_BCC-CSM2-MR_ssp126_10m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of warmest quarter","P of warmest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio19","bio19","WorldClim_2.1_BCC-CSM2-MR_ssp126_10m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of coldest quarter","P of coldest qtr","year","mm per quarter","*mm~qtr^-1*", +"precipitation_01","precipitation_01","WorldClim_2.1_BCC-CSM2-MR_ssp126_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jan","P Jan","january","mm per month","*mm~mo^-1*", +"precipitation_02","precipitation_02","WorldClim_2.1_BCC-CSM2-MR_ssp126_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Feb","P Feb","february","mm per month","*mm~mo^-1*", +"precipitation_03","precipitation_03","WorldClim_2.1_BCC-CSM2-MR_ssp126_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Mar","P Mar","march","mm per month","*mm~mo^-1*", +"precipitation_04","precipitation_04","WorldClim_2.1_BCC-CSM2-MR_ssp126_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Apr","P Apr","april","mm per month","*mm~mo^-1*", +"precipitation_05","precipitation_05","WorldClim_2.1_BCC-CSM2-MR_ssp126_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation May","P May","may","mm per month","*mm~mo^-1*", +"precipitation_06","precipitation_06","WorldClim_2.1_BCC-CSM2-MR_ssp126_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jun","P Jun","june","mm per month","*mm~mo^-1*", +"precipitation_07","precipitation_07","WorldClim_2.1_BCC-CSM2-MR_ssp126_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jul","P Jul","july","mm per month","*mm~mo^-1*", +"precipitation_08","precipitation_08","WorldClim_2.1_BCC-CSM2-MR_ssp126_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Aug","P Aug","august","mm per month","*mm~mo^-1*", +"precipitation_09","precipitation_09","WorldClim_2.1_BCC-CSM2-MR_ssp126_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Sep","P Sep","september","mm per month","*mm~mo^-1*", +"precipitation_10","precipitation_10","WorldClim_2.1_BCC-CSM2-MR_ssp126_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Oct","P Oct","october","mm per month","*mm~mo^-1*", +"precipitation_11","precipitation_11","WorldClim_2.1_BCC-CSM2-MR_ssp126_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Nov","P Nov","november","mm per month","*mm~mo^-1*", +"precipitation_12","precipitation_12","WorldClim_2.1_BCC-CSM2-MR_ssp126_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Dec","P Dec","december","mm per month","*mm~mo^-1*", +"temperature_min_01","temperature_min_01","WorldClim_2.1_BCC-CSM2-MR_ssp126_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jan","min T Jan","january","degrees Celsius","*degree*C*", +"temperature_min_02","temperature_min_02","WorldClim_2.1_BCC-CSM2-MR_ssp126_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Feb","min T Feb","february","degrees Celsius","*degree*C*", +"temperature_min_03","temperature_min_03","WorldClim_2.1_BCC-CSM2-MR_ssp126_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Mar","min T Mar","march","degrees Celsius","*degree*C*", +"temperature_min_04","temperature_min_04","WorldClim_2.1_BCC-CSM2-MR_ssp126_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Apr","min T Apr","april","degrees Celsius","*degree*C*", +"temperature_min_05","temperature_min_05","WorldClim_2.1_BCC-CSM2-MR_ssp126_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature May","min T May","may","degrees Celsius","*degree*C*", +"temperature_min_06","temperature_min_06","WorldClim_2.1_BCC-CSM2-MR_ssp126_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jun","min T Jun","june","degrees Celsius","*degree*C*", +"temperature_min_07","temperature_min_07","WorldClim_2.1_BCC-CSM2-MR_ssp126_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jul","min T Jul","july","degrees Celsius","*degree*C*", +"temperature_min_08","temperature_min_08","WorldClim_2.1_BCC-CSM2-MR_ssp126_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Aug","min T Aug","august","degrees Celsius","*degree*C*", +"temperature_min_09","temperature_min_09","WorldClim_2.1_BCC-CSM2-MR_ssp126_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Sep","min T Sep","september","degrees Celsius","*degree*C*", +"temperature_min_10","temperature_min_10","WorldClim_2.1_BCC-CSM2-MR_ssp126_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Oct","min T Oct","october","degrees Celsius","*degree*C*", +"temperature_min_11","temperature_min_11","WorldClim_2.1_BCC-CSM2-MR_ssp126_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Nov","min T Nov","november","degrees Celsius","*degree*C*", +"temperature_min_12","temperature_min_12","WorldClim_2.1_BCC-CSM2-MR_ssp126_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Dec","min T Dec","december","degrees Celsius","*degree*C*", +"temperature_max_01","temperature_max_01","WorldClim_2.1_BCC-CSM2-MR_ssp126_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jan","max T Jan","january","degrees Celsius","*degree*C*", +"temperature_max_02","temperature_max_02","WorldClim_2.1_BCC-CSM2-MR_ssp126_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Feb","max T Feb","february","degrees Celsius","*degree*C*", +"temperature_max_03","temperature_max_03","WorldClim_2.1_BCC-CSM2-MR_ssp126_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Mar","max T Mar","march","degrees Celsius","*degree*C*", +"temperature_max_04","temperature_max_04","WorldClim_2.1_BCC-CSM2-MR_ssp126_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Apr","max T Apr","april","degrees Celsius","*degree*C*", +"temperature_max_05","temperature_max_05","WorldClim_2.1_BCC-CSM2-MR_ssp126_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature May","max T May","may","degrees Celsius","*degree*C*", +"temperature_max_06","temperature_max_06","WorldClim_2.1_BCC-CSM2-MR_ssp126_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jun","max T Jun","june","degrees Celsius","*degree*C*", +"temperature_max_07","temperature_max_07","WorldClim_2.1_BCC-CSM2-MR_ssp126_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jul","max T Jul","july","degrees Celsius","*degree*C*", +"temperature_max_08","temperature_max_08","WorldClim_2.1_BCC-CSM2-MR_ssp126_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Aug","max T Aug","august","degrees Celsius","*degree*C*", +"temperature_max_09","temperature_max_09","WorldClim_2.1_BCC-CSM2-MR_ssp126_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Sep","max T Sep","september","degrees Celsius","*degree*C*", +"temperature_max_10","temperature_max_10","WorldClim_2.1_BCC-CSM2-MR_ssp126_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Oct","max T Oct","october","degrees Celsius","*degree*C*", +"temperature_max_11","temperature_max_11","WorldClim_2.1_BCC-CSM2-MR_ssp126_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Nov","max T Nov","november","degrees Celsius","*degree*C*", +"temperature_max_12","temperature_max_12","WorldClim_2.1_BCC-CSM2-MR_ssp126_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Dec","max T Dec","december","degrees Celsius","*degree*C*", +"bio01","bio01","WorldClim_2.1_BCC-CSM2-MR_ssp126_5m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual mean temperature","ann. mean T","year","degrees Celsius","*degree*C*", +"bio02","bio02","WorldClim_2.1_BCC-CSM2-MR_ssp126_5m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean diurnal range","diurn. range","year","degrees Celsius","*degree*C*", +"bio03","bio03","WorldClim_2.1_BCC-CSM2-MR_ssp126_5m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","isothermality","isothermality","year","","", +"bio04","bio04","WorldClim_2.1_BCC-CSM2-MR_ssp126_5m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature seasonality","T season.","year","degrees Celsius","*degree*C*", +"bio05","bio05","WorldClim_2.1_BCC-CSM2-MR_ssp126_5m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature of warmest month","max. T of warmest mo.","year","degrees Celsius","*degree*C*", +"bio06","bio06","WorldClim_2.1_BCC-CSM2-MR_ssp126_5m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature of coldest month","min. T of coldest mo.","year","degrees Celsius","*degree*C*", +"bio07","bio07","WorldClim_2.1_BCC-CSM2-MR_ssp126_5m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature annual range (bio05-bio06)","T ann. Range","year","degrees Celsius","*degree*C*", +"bio08","bio08","WorldClim_2.1_BCC-CSM2-MR_ssp126_5m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of wettest quarter","mean T of wettest qtr","year","degrees Celsius","*degree*C*", +"bio09","bio09","WorldClim_2.1_BCC-CSM2-MR_ssp126_5m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of driest quarter","mean T of driest qtr","year","degrees Celsius","*degree*C*", +"bio10","bio10","WorldClim_2.1_BCC-CSM2-MR_ssp126_5m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of warmest quarter","mean T of warmest qtr","year","degrees Celsius","*degree*C*", +"bio11","bio11","WorldClim_2.1_BCC-CSM2-MR_ssp126_5m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of coldest quarter","mean T of coldest qtr","year","degrees Celsius","*degree*C*", +"bio12","bio12","WorldClim_2.1_BCC-CSM2-MR_ssp126_5m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual precipitation","ann. P","year","mm per year","*mm~yr^-1*", +"bio13","bio13","WorldClim_2.1_BCC-CSM2-MR_ssp126_5m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest month","P of wettest mo.","year","mm per month","*mm~mo^-1*", +"bio14","bio14","WorldClim_2.1_BCC-CSM2-MR_ssp126_5m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest month","P of driest mo.","year","mm per month","*mm~mo^-1*", +"bio15","bio15","WorldClim_2.1_BCC-CSM2-MR_ssp126_5m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation seasonality (coeff var)","P season.","year","","", +"bio16","bio16","WorldClim_2.1_BCC-CSM2-MR_ssp126_5m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest quarter","P of wettest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio17","bio17","WorldClim_2.1_BCC-CSM2-MR_ssp126_5m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest quarter","P of driest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio18","bio18","WorldClim_2.1_BCC-CSM2-MR_ssp126_5m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of warmest quarter","P of warmest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio19","bio19","WorldClim_2.1_BCC-CSM2-MR_ssp126_5m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of coldest quarter","P of coldest qtr","year","mm per quarter","*mm~qtr^-1*", +"precipitation_01","precipitation_01","WorldClim_2.1_BCC-CSM2-MR_ssp126_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jan","P Jan","january","mm per month","*mm~mo^-1*", +"precipitation_02","precipitation_02","WorldClim_2.1_BCC-CSM2-MR_ssp126_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Feb","P Feb","february","mm per month","*mm~mo^-1*", +"precipitation_03","precipitation_03","WorldClim_2.1_BCC-CSM2-MR_ssp126_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Mar","P Mar","march","mm per month","*mm~mo^-1*", +"precipitation_04","precipitation_04","WorldClim_2.1_BCC-CSM2-MR_ssp126_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Apr","P Apr","april","mm per month","*mm~mo^-1*", +"precipitation_05","precipitation_05","WorldClim_2.1_BCC-CSM2-MR_ssp126_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation May","P May","may","mm per month","*mm~mo^-1*", +"precipitation_06","precipitation_06","WorldClim_2.1_BCC-CSM2-MR_ssp126_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jun","P Jun","june","mm per month","*mm~mo^-1*", +"precipitation_07","precipitation_07","WorldClim_2.1_BCC-CSM2-MR_ssp126_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jul","P Jul","july","mm per month","*mm~mo^-1*", +"precipitation_08","precipitation_08","WorldClim_2.1_BCC-CSM2-MR_ssp126_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Aug","P Aug","august","mm per month","*mm~mo^-1*", +"precipitation_09","precipitation_09","WorldClim_2.1_BCC-CSM2-MR_ssp126_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Sep","P Sep","september","mm per month","*mm~mo^-1*", +"precipitation_10","precipitation_10","WorldClim_2.1_BCC-CSM2-MR_ssp126_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Oct","P Oct","october","mm per month","*mm~mo^-1*", +"precipitation_11","precipitation_11","WorldClim_2.1_BCC-CSM2-MR_ssp126_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Nov","P Nov","november","mm per month","*mm~mo^-1*", +"precipitation_12","precipitation_12","WorldClim_2.1_BCC-CSM2-MR_ssp126_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Dec","P Dec","december","mm per month","*mm~mo^-1*", +"temperature_min_01","temperature_min_01","WorldClim_2.1_BCC-CSM2-MR_ssp126_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jan","min T Jan","january","degrees Celsius","*degree*C*", +"temperature_min_02","temperature_min_02","WorldClim_2.1_BCC-CSM2-MR_ssp126_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Feb","min T Feb","february","degrees Celsius","*degree*C*", +"temperature_min_03","temperature_min_03","WorldClim_2.1_BCC-CSM2-MR_ssp126_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Mar","min T Mar","march","degrees Celsius","*degree*C*", +"temperature_min_04","temperature_min_04","WorldClim_2.1_BCC-CSM2-MR_ssp126_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Apr","min T Apr","april","degrees Celsius","*degree*C*", +"temperature_min_05","temperature_min_05","WorldClim_2.1_BCC-CSM2-MR_ssp126_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature May","min T May","may","degrees Celsius","*degree*C*", +"temperature_min_06","temperature_min_06","WorldClim_2.1_BCC-CSM2-MR_ssp126_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jun","min T Jun","june","degrees Celsius","*degree*C*", +"temperature_min_07","temperature_min_07","WorldClim_2.1_BCC-CSM2-MR_ssp126_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jul","min T Jul","july","degrees Celsius","*degree*C*", +"temperature_min_08","temperature_min_08","WorldClim_2.1_BCC-CSM2-MR_ssp126_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Aug","min T Aug","august","degrees Celsius","*degree*C*", +"temperature_min_09","temperature_min_09","WorldClim_2.1_BCC-CSM2-MR_ssp126_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Sep","min T Sep","september","degrees Celsius","*degree*C*", +"temperature_min_10","temperature_min_10","WorldClim_2.1_BCC-CSM2-MR_ssp126_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Oct","min T Oct","october","degrees Celsius","*degree*C*", +"temperature_min_11","temperature_min_11","WorldClim_2.1_BCC-CSM2-MR_ssp126_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Nov","min T Nov","november","degrees Celsius","*degree*C*", +"temperature_min_12","temperature_min_12","WorldClim_2.1_BCC-CSM2-MR_ssp126_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Dec","min T Dec","december","degrees Celsius","*degree*C*", +"temperature_max_01","temperature_max_01","WorldClim_2.1_BCC-CSM2-MR_ssp126_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jan","max T Jan","january","degrees Celsius","*degree*C*", +"temperature_max_02","temperature_max_02","WorldClim_2.1_BCC-CSM2-MR_ssp126_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Feb","max T Feb","february","degrees Celsius","*degree*C*", +"temperature_max_03","temperature_max_03","WorldClim_2.1_BCC-CSM2-MR_ssp126_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Mar","max T Mar","march","degrees Celsius","*degree*C*", +"temperature_max_04","temperature_max_04","WorldClim_2.1_BCC-CSM2-MR_ssp126_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Apr","max T Apr","april","degrees Celsius","*degree*C*", +"temperature_max_05","temperature_max_05","WorldClim_2.1_BCC-CSM2-MR_ssp126_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature May","max T May","may","degrees Celsius","*degree*C*", +"temperature_max_06","temperature_max_06","WorldClim_2.1_BCC-CSM2-MR_ssp126_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jun","max T Jun","june","degrees Celsius","*degree*C*", +"temperature_max_07","temperature_max_07","WorldClim_2.1_BCC-CSM2-MR_ssp126_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jul","max T Jul","july","degrees Celsius","*degree*C*", +"temperature_max_08","temperature_max_08","WorldClim_2.1_BCC-CSM2-MR_ssp126_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Aug","max T Aug","august","degrees Celsius","*degree*C*", +"temperature_max_09","temperature_max_09","WorldClim_2.1_BCC-CSM2-MR_ssp126_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Sep","max T Sep","september","degrees Celsius","*degree*C*", +"temperature_max_10","temperature_max_10","WorldClim_2.1_BCC-CSM2-MR_ssp126_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Oct","max T Oct","october","degrees Celsius","*degree*C*", +"temperature_max_11","temperature_max_11","WorldClim_2.1_BCC-CSM2-MR_ssp126_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Nov","max T Nov","november","degrees Celsius","*degree*C*", +"temperature_max_12","temperature_max_12","WorldClim_2.1_BCC-CSM2-MR_ssp126_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Dec","max T Dec","december","degrees Celsius","*degree*C*", +"bio01","bio01","WorldClim_2.1_BCC-CSM2-MR_ssp245_10m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual mean temperature","ann. mean T","year","degrees Celsius","*degree*C*", +"bio02","bio02","WorldClim_2.1_BCC-CSM2-MR_ssp245_10m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean diurnal range","diurn. range","year","degrees Celsius","*degree*C*", +"bio03","bio03","WorldClim_2.1_BCC-CSM2-MR_ssp245_10m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","isothermality","isothermality","year","","", +"bio04","bio04","WorldClim_2.1_BCC-CSM2-MR_ssp245_10m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature seasonality","T season.","year","degrees Celsius","*degree*C*", +"bio05","bio05","WorldClim_2.1_BCC-CSM2-MR_ssp245_10m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature of warmest month","max. T of warmest mo.","year","degrees Celsius","*degree*C*", +"bio06","bio06","WorldClim_2.1_BCC-CSM2-MR_ssp245_10m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature of coldest month","min. T of coldest mo.","year","degrees Celsius","*degree*C*", +"bio07","bio07","WorldClim_2.1_BCC-CSM2-MR_ssp245_10m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature annual range (bio05-bio06)","T ann. Range","year","degrees Celsius","*degree*C*", +"bio08","bio08","WorldClim_2.1_BCC-CSM2-MR_ssp245_10m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of wettest quarter","mean T of wettest qtr","year","degrees Celsius","*degree*C*", +"bio09","bio09","WorldClim_2.1_BCC-CSM2-MR_ssp245_10m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of driest quarter","mean T of driest qtr","year","degrees Celsius","*degree*C*", +"bio10","bio10","WorldClim_2.1_BCC-CSM2-MR_ssp245_10m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of warmest quarter","mean T of warmest qtr","year","degrees Celsius","*degree*C*", +"bio11","bio11","WorldClim_2.1_BCC-CSM2-MR_ssp245_10m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of coldest quarter","mean T of coldest qtr","year","degrees Celsius","*degree*C*", +"bio12","bio12","WorldClim_2.1_BCC-CSM2-MR_ssp245_10m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual precipitation","ann. P","year","mm per year","*mm~yr^-1*", +"bio13","bio13","WorldClim_2.1_BCC-CSM2-MR_ssp245_10m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest month","P of wettest mo.","year","mm per month","*mm~mo^-1*", +"bio14","bio14","WorldClim_2.1_BCC-CSM2-MR_ssp245_10m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest month","P of driest mo.","year","mm per month","*mm~mo^-1*", +"bio15","bio15","WorldClim_2.1_BCC-CSM2-MR_ssp245_10m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation seasonality (coeff var)","P season.","year","","", +"bio16","bio16","WorldClim_2.1_BCC-CSM2-MR_ssp245_10m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest quarter","P of wettest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio17","bio17","WorldClim_2.1_BCC-CSM2-MR_ssp245_10m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest quarter","P of driest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio18","bio18","WorldClim_2.1_BCC-CSM2-MR_ssp245_10m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of warmest quarter","P of warmest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio19","bio19","WorldClim_2.1_BCC-CSM2-MR_ssp245_10m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of coldest quarter","P of coldest qtr","year","mm per quarter","*mm~qtr^-1*", +"precipitation_01","precipitation_01","WorldClim_2.1_BCC-CSM2-MR_ssp245_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jan","P Jan","january","mm per month","*mm~mo^-1*", +"precipitation_02","precipitation_02","WorldClim_2.1_BCC-CSM2-MR_ssp245_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Feb","P Feb","february","mm per month","*mm~mo^-1*", +"precipitation_03","precipitation_03","WorldClim_2.1_BCC-CSM2-MR_ssp245_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Mar","P Mar","march","mm per month","*mm~mo^-1*", +"precipitation_04","precipitation_04","WorldClim_2.1_BCC-CSM2-MR_ssp245_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Apr","P Apr","april","mm per month","*mm~mo^-1*", +"precipitation_05","precipitation_05","WorldClim_2.1_BCC-CSM2-MR_ssp245_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation May","P May","may","mm per month","*mm~mo^-1*", +"precipitation_06","precipitation_06","WorldClim_2.1_BCC-CSM2-MR_ssp245_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jun","P Jun","june","mm per month","*mm~mo^-1*", +"precipitation_07","precipitation_07","WorldClim_2.1_BCC-CSM2-MR_ssp245_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jul","P Jul","july","mm per month","*mm~mo^-1*", +"precipitation_08","precipitation_08","WorldClim_2.1_BCC-CSM2-MR_ssp245_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Aug","P Aug","august","mm per month","*mm~mo^-1*", +"precipitation_09","precipitation_09","WorldClim_2.1_BCC-CSM2-MR_ssp245_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Sep","P Sep","september","mm per month","*mm~mo^-1*", +"precipitation_10","precipitation_10","WorldClim_2.1_BCC-CSM2-MR_ssp245_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Oct","P Oct","october","mm per month","*mm~mo^-1*", +"precipitation_11","precipitation_11","WorldClim_2.1_BCC-CSM2-MR_ssp245_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Nov","P Nov","november","mm per month","*mm~mo^-1*", +"precipitation_12","precipitation_12","WorldClim_2.1_BCC-CSM2-MR_ssp245_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Dec","P Dec","december","mm per month","*mm~mo^-1*", +"temperature_min_01","temperature_min_01","WorldClim_2.1_BCC-CSM2-MR_ssp245_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jan","min T Jan","january","degrees Celsius","*degree*C*", +"temperature_min_02","temperature_min_02","WorldClim_2.1_BCC-CSM2-MR_ssp245_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Feb","min T Feb","february","degrees Celsius","*degree*C*", +"temperature_min_03","temperature_min_03","WorldClim_2.1_BCC-CSM2-MR_ssp245_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Mar","min T Mar","march","degrees Celsius","*degree*C*", +"temperature_min_04","temperature_min_04","WorldClim_2.1_BCC-CSM2-MR_ssp245_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Apr","min T Apr","april","degrees Celsius","*degree*C*", +"temperature_min_05","temperature_min_05","WorldClim_2.1_BCC-CSM2-MR_ssp245_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature May","min T May","may","degrees Celsius","*degree*C*", +"temperature_min_06","temperature_min_06","WorldClim_2.1_BCC-CSM2-MR_ssp245_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jun","min T Jun","june","degrees Celsius","*degree*C*", +"temperature_min_07","temperature_min_07","WorldClim_2.1_BCC-CSM2-MR_ssp245_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jul","min T Jul","july","degrees Celsius","*degree*C*", +"temperature_min_08","temperature_min_08","WorldClim_2.1_BCC-CSM2-MR_ssp245_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Aug","min T Aug","august","degrees Celsius","*degree*C*", +"temperature_min_09","temperature_min_09","WorldClim_2.1_BCC-CSM2-MR_ssp245_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Sep","min T Sep","september","degrees Celsius","*degree*C*", +"temperature_min_10","temperature_min_10","WorldClim_2.1_BCC-CSM2-MR_ssp245_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Oct","min T Oct","october","degrees Celsius","*degree*C*", +"temperature_min_11","temperature_min_11","WorldClim_2.1_BCC-CSM2-MR_ssp245_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Nov","min T Nov","november","degrees Celsius","*degree*C*", +"temperature_min_12","temperature_min_12","WorldClim_2.1_BCC-CSM2-MR_ssp245_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Dec","min T Dec","december","degrees Celsius","*degree*C*", +"temperature_max_01","temperature_max_01","WorldClim_2.1_BCC-CSM2-MR_ssp245_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jan","max T Jan","january","degrees Celsius","*degree*C*", +"temperature_max_02","temperature_max_02","WorldClim_2.1_BCC-CSM2-MR_ssp245_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Feb","max T Feb","february","degrees Celsius","*degree*C*", +"temperature_max_03","temperature_max_03","WorldClim_2.1_BCC-CSM2-MR_ssp245_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Mar","max T Mar","march","degrees Celsius","*degree*C*", +"temperature_max_04","temperature_max_04","WorldClim_2.1_BCC-CSM2-MR_ssp245_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Apr","max T Apr","april","degrees Celsius","*degree*C*", +"temperature_max_05","temperature_max_05","WorldClim_2.1_BCC-CSM2-MR_ssp245_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature May","max T May","may","degrees Celsius","*degree*C*", +"temperature_max_06","temperature_max_06","WorldClim_2.1_BCC-CSM2-MR_ssp245_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jun","max T Jun","june","degrees Celsius","*degree*C*", +"temperature_max_07","temperature_max_07","WorldClim_2.1_BCC-CSM2-MR_ssp245_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jul","max T Jul","july","degrees Celsius","*degree*C*", +"temperature_max_08","temperature_max_08","WorldClim_2.1_BCC-CSM2-MR_ssp245_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Aug","max T Aug","august","degrees Celsius","*degree*C*", +"temperature_max_09","temperature_max_09","WorldClim_2.1_BCC-CSM2-MR_ssp245_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Sep","max T Sep","september","degrees Celsius","*degree*C*", +"temperature_max_10","temperature_max_10","WorldClim_2.1_BCC-CSM2-MR_ssp245_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Oct","max T Oct","october","degrees Celsius","*degree*C*", +"temperature_max_11","temperature_max_11","WorldClim_2.1_BCC-CSM2-MR_ssp245_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Nov","max T Nov","november","degrees Celsius","*degree*C*", +"temperature_max_12","temperature_max_12","WorldClim_2.1_BCC-CSM2-MR_ssp245_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Dec","max T Dec","december","degrees Celsius","*degree*C*", +"bio01","bio01","WorldClim_2.1_BCC-CSM2-MR_ssp245_5m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual mean temperature","ann. mean T","year","degrees Celsius","*degree*C*", +"bio02","bio02","WorldClim_2.1_BCC-CSM2-MR_ssp245_5m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean diurnal range","diurn. range","year","degrees Celsius","*degree*C*", +"bio03","bio03","WorldClim_2.1_BCC-CSM2-MR_ssp245_5m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","isothermality","isothermality","year","","", +"bio04","bio04","WorldClim_2.1_BCC-CSM2-MR_ssp245_5m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature seasonality","T season.","year","degrees Celsius","*degree*C*", +"bio05","bio05","WorldClim_2.1_BCC-CSM2-MR_ssp245_5m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature of warmest month","max. T of warmest mo.","year","degrees Celsius","*degree*C*", +"bio06","bio06","WorldClim_2.1_BCC-CSM2-MR_ssp245_5m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature of coldest month","min. T of coldest mo.","year","degrees Celsius","*degree*C*", +"bio07","bio07","WorldClim_2.1_BCC-CSM2-MR_ssp245_5m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature annual range (bio05-bio06)","T ann. Range","year","degrees Celsius","*degree*C*", +"bio08","bio08","WorldClim_2.1_BCC-CSM2-MR_ssp245_5m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of wettest quarter","mean T of wettest qtr","year","degrees Celsius","*degree*C*", +"bio09","bio09","WorldClim_2.1_BCC-CSM2-MR_ssp245_5m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of driest quarter","mean T of driest qtr","year","degrees Celsius","*degree*C*", +"bio10","bio10","WorldClim_2.1_BCC-CSM2-MR_ssp245_5m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of warmest quarter","mean T of warmest qtr","year","degrees Celsius","*degree*C*", +"bio11","bio11","WorldClim_2.1_BCC-CSM2-MR_ssp245_5m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of coldest quarter","mean T of coldest qtr","year","degrees Celsius","*degree*C*", +"bio12","bio12","WorldClim_2.1_BCC-CSM2-MR_ssp245_5m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual precipitation","ann. P","year","mm per year","*mm~yr^-1*", +"bio13","bio13","WorldClim_2.1_BCC-CSM2-MR_ssp245_5m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest month","P of wettest mo.","year","mm per month","*mm~mo^-1*", +"bio14","bio14","WorldClim_2.1_BCC-CSM2-MR_ssp245_5m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest month","P of driest mo.","year","mm per month","*mm~mo^-1*", +"bio15","bio15","WorldClim_2.1_BCC-CSM2-MR_ssp245_5m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation seasonality (coeff var)","P season.","year","","", +"bio16","bio16","WorldClim_2.1_BCC-CSM2-MR_ssp245_5m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest quarter","P of wettest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio17","bio17","WorldClim_2.1_BCC-CSM2-MR_ssp245_5m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest quarter","P of driest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio18","bio18","WorldClim_2.1_BCC-CSM2-MR_ssp245_5m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of warmest quarter","P of warmest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio19","bio19","WorldClim_2.1_BCC-CSM2-MR_ssp245_5m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of coldest quarter","P of coldest qtr","year","mm per quarter","*mm~qtr^-1*", +"precipitation_01","precipitation_01","WorldClim_2.1_BCC-CSM2-MR_ssp245_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jan","P Jan","january","mm per month","*mm~mo^-1*", +"precipitation_02","precipitation_02","WorldClim_2.1_BCC-CSM2-MR_ssp245_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Feb","P Feb","february","mm per month","*mm~mo^-1*", +"precipitation_03","precipitation_03","WorldClim_2.1_BCC-CSM2-MR_ssp245_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Mar","P Mar","march","mm per month","*mm~mo^-1*", +"precipitation_04","precipitation_04","WorldClim_2.1_BCC-CSM2-MR_ssp245_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Apr","P Apr","april","mm per month","*mm~mo^-1*", +"precipitation_05","precipitation_05","WorldClim_2.1_BCC-CSM2-MR_ssp245_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation May","P May","may","mm per month","*mm~mo^-1*", +"precipitation_06","precipitation_06","WorldClim_2.1_BCC-CSM2-MR_ssp245_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jun","P Jun","june","mm per month","*mm~mo^-1*", +"precipitation_07","precipitation_07","WorldClim_2.1_BCC-CSM2-MR_ssp245_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jul","P Jul","july","mm per month","*mm~mo^-1*", +"precipitation_08","precipitation_08","WorldClim_2.1_BCC-CSM2-MR_ssp245_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Aug","P Aug","august","mm per month","*mm~mo^-1*", +"precipitation_09","precipitation_09","WorldClim_2.1_BCC-CSM2-MR_ssp245_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Sep","P Sep","september","mm per month","*mm~mo^-1*", +"precipitation_10","precipitation_10","WorldClim_2.1_BCC-CSM2-MR_ssp245_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Oct","P Oct","october","mm per month","*mm~mo^-1*", +"precipitation_11","precipitation_11","WorldClim_2.1_BCC-CSM2-MR_ssp245_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Nov","P Nov","november","mm per month","*mm~mo^-1*", +"precipitation_12","precipitation_12","WorldClim_2.1_BCC-CSM2-MR_ssp245_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Dec","P Dec","december","mm per month","*mm~mo^-1*", +"temperature_min_01","temperature_min_01","WorldClim_2.1_BCC-CSM2-MR_ssp245_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jan","min T Jan","january","degrees Celsius","*degree*C*", +"temperature_min_02","temperature_min_02","WorldClim_2.1_BCC-CSM2-MR_ssp245_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Feb","min T Feb","february","degrees Celsius","*degree*C*", +"temperature_min_03","temperature_min_03","WorldClim_2.1_BCC-CSM2-MR_ssp245_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Mar","min T Mar","march","degrees Celsius","*degree*C*", +"temperature_min_04","temperature_min_04","WorldClim_2.1_BCC-CSM2-MR_ssp245_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Apr","min T Apr","april","degrees Celsius","*degree*C*", +"temperature_min_05","temperature_min_05","WorldClim_2.1_BCC-CSM2-MR_ssp245_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature May","min T May","may","degrees Celsius","*degree*C*", +"temperature_min_06","temperature_min_06","WorldClim_2.1_BCC-CSM2-MR_ssp245_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jun","min T Jun","june","degrees Celsius","*degree*C*", +"temperature_min_07","temperature_min_07","WorldClim_2.1_BCC-CSM2-MR_ssp245_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jul","min T Jul","july","degrees Celsius","*degree*C*", +"temperature_min_08","temperature_min_08","WorldClim_2.1_BCC-CSM2-MR_ssp245_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Aug","min T Aug","august","degrees Celsius","*degree*C*", +"temperature_min_09","temperature_min_09","WorldClim_2.1_BCC-CSM2-MR_ssp245_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Sep","min T Sep","september","degrees Celsius","*degree*C*", +"temperature_min_10","temperature_min_10","WorldClim_2.1_BCC-CSM2-MR_ssp245_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Oct","min T Oct","october","degrees Celsius","*degree*C*", +"temperature_min_11","temperature_min_11","WorldClim_2.1_BCC-CSM2-MR_ssp245_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Nov","min T Nov","november","degrees Celsius","*degree*C*", +"temperature_min_12","temperature_min_12","WorldClim_2.1_BCC-CSM2-MR_ssp245_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Dec","min T Dec","december","degrees Celsius","*degree*C*", +"temperature_max_01","temperature_max_01","WorldClim_2.1_BCC-CSM2-MR_ssp245_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jan","max T Jan","january","degrees Celsius","*degree*C*", +"temperature_max_02","temperature_max_02","WorldClim_2.1_BCC-CSM2-MR_ssp245_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Feb","max T Feb","february","degrees Celsius","*degree*C*", +"temperature_max_03","temperature_max_03","WorldClim_2.1_BCC-CSM2-MR_ssp245_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Mar","max T Mar","march","degrees Celsius","*degree*C*", +"temperature_max_04","temperature_max_04","WorldClim_2.1_BCC-CSM2-MR_ssp245_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Apr","max T Apr","april","degrees Celsius","*degree*C*", +"temperature_max_05","temperature_max_05","WorldClim_2.1_BCC-CSM2-MR_ssp245_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature May","max T May","may","degrees Celsius","*degree*C*", +"temperature_max_06","temperature_max_06","WorldClim_2.1_BCC-CSM2-MR_ssp245_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jun","max T Jun","june","degrees Celsius","*degree*C*", +"temperature_max_07","temperature_max_07","WorldClim_2.1_BCC-CSM2-MR_ssp245_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jul","max T Jul","july","degrees Celsius","*degree*C*", +"temperature_max_08","temperature_max_08","WorldClim_2.1_BCC-CSM2-MR_ssp245_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Aug","max T Aug","august","degrees Celsius","*degree*C*", +"temperature_max_09","temperature_max_09","WorldClim_2.1_BCC-CSM2-MR_ssp245_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Sep","max T Sep","september","degrees Celsius","*degree*C*", +"temperature_max_10","temperature_max_10","WorldClim_2.1_BCC-CSM2-MR_ssp245_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Oct","max T Oct","october","degrees Celsius","*degree*C*", +"temperature_max_11","temperature_max_11","WorldClim_2.1_BCC-CSM2-MR_ssp245_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Nov","max T Nov","november","degrees Celsius","*degree*C*", +"temperature_max_12","temperature_max_12","WorldClim_2.1_BCC-CSM2-MR_ssp245_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Dec","max T Dec","december","degrees Celsius","*degree*C*", +"bio01","bio01","WorldClim_2.1_BCC-CSM2-MR_ssp370_10m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual mean temperature","ann. mean T","year","degrees Celsius","*degree*C*", +"bio02","bio02","WorldClim_2.1_BCC-CSM2-MR_ssp370_10m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean diurnal range","diurn. range","year","degrees Celsius","*degree*C*", +"bio03","bio03","WorldClim_2.1_BCC-CSM2-MR_ssp370_10m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","isothermality","isothermality","year","","", +"bio04","bio04","WorldClim_2.1_BCC-CSM2-MR_ssp370_10m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature seasonality","T season.","year","degrees Celsius","*degree*C*", +"bio05","bio05","WorldClim_2.1_BCC-CSM2-MR_ssp370_10m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature of warmest month","max. T of warmest mo.","year","degrees Celsius","*degree*C*", +"bio06","bio06","WorldClim_2.1_BCC-CSM2-MR_ssp370_10m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature of coldest month","min. T of coldest mo.","year","degrees Celsius","*degree*C*", +"bio07","bio07","WorldClim_2.1_BCC-CSM2-MR_ssp370_10m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature annual range (bio05-bio06)","T ann. Range","year","degrees Celsius","*degree*C*", +"bio08","bio08","WorldClim_2.1_BCC-CSM2-MR_ssp370_10m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of wettest quarter","mean T of wettest qtr","year","degrees Celsius","*degree*C*", +"bio09","bio09","WorldClim_2.1_BCC-CSM2-MR_ssp370_10m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of driest quarter","mean T of driest qtr","year","degrees Celsius","*degree*C*", +"bio10","bio10","WorldClim_2.1_BCC-CSM2-MR_ssp370_10m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of warmest quarter","mean T of warmest qtr","year","degrees Celsius","*degree*C*", +"bio11","bio11","WorldClim_2.1_BCC-CSM2-MR_ssp370_10m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of coldest quarter","mean T of coldest qtr","year","degrees Celsius","*degree*C*", +"bio12","bio12","WorldClim_2.1_BCC-CSM2-MR_ssp370_10m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual precipitation","ann. P","year","mm per year","*mm~yr^-1*", +"bio13","bio13","WorldClim_2.1_BCC-CSM2-MR_ssp370_10m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest month","P of wettest mo.","year","mm per month","*mm~mo^-1*", +"bio14","bio14","WorldClim_2.1_BCC-CSM2-MR_ssp370_10m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest month","P of driest mo.","year","mm per month","*mm~mo^-1*", +"bio15","bio15","WorldClim_2.1_BCC-CSM2-MR_ssp370_10m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation seasonality (coeff var)","P season.","year","","", +"bio16","bio16","WorldClim_2.1_BCC-CSM2-MR_ssp370_10m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest quarter","P of wettest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio17","bio17","WorldClim_2.1_BCC-CSM2-MR_ssp370_10m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest quarter","P of driest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio18","bio18","WorldClim_2.1_BCC-CSM2-MR_ssp370_10m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of warmest quarter","P of warmest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio19","bio19","WorldClim_2.1_BCC-CSM2-MR_ssp370_10m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of coldest quarter","P of coldest qtr","year","mm per quarter","*mm~qtr^-1*", +"precipitation_01","precipitation_01","WorldClim_2.1_BCC-CSM2-MR_ssp370_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jan","P Jan","january","mm per month","*mm~mo^-1*", +"precipitation_02","precipitation_02","WorldClim_2.1_BCC-CSM2-MR_ssp370_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Feb","P Feb","february","mm per month","*mm~mo^-1*", +"precipitation_03","precipitation_03","WorldClim_2.1_BCC-CSM2-MR_ssp370_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Mar","P Mar","march","mm per month","*mm~mo^-1*", +"precipitation_04","precipitation_04","WorldClim_2.1_BCC-CSM2-MR_ssp370_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Apr","P Apr","april","mm per month","*mm~mo^-1*", +"precipitation_05","precipitation_05","WorldClim_2.1_BCC-CSM2-MR_ssp370_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation May","P May","may","mm per month","*mm~mo^-1*", +"precipitation_06","precipitation_06","WorldClim_2.1_BCC-CSM2-MR_ssp370_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jun","P Jun","june","mm per month","*mm~mo^-1*", +"precipitation_07","precipitation_07","WorldClim_2.1_BCC-CSM2-MR_ssp370_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jul","P Jul","july","mm per month","*mm~mo^-1*", +"precipitation_08","precipitation_08","WorldClim_2.1_BCC-CSM2-MR_ssp370_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Aug","P Aug","august","mm per month","*mm~mo^-1*", +"precipitation_09","precipitation_09","WorldClim_2.1_BCC-CSM2-MR_ssp370_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Sep","P Sep","september","mm per month","*mm~mo^-1*", +"precipitation_10","precipitation_10","WorldClim_2.1_BCC-CSM2-MR_ssp370_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Oct","P Oct","october","mm per month","*mm~mo^-1*", +"precipitation_11","precipitation_11","WorldClim_2.1_BCC-CSM2-MR_ssp370_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Nov","P Nov","november","mm per month","*mm~mo^-1*", +"precipitation_12","precipitation_12","WorldClim_2.1_BCC-CSM2-MR_ssp370_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Dec","P Dec","december","mm per month","*mm~mo^-1*", +"temperature_min_01","temperature_min_01","WorldClim_2.1_BCC-CSM2-MR_ssp370_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jan","min T Jan","january","degrees Celsius","*degree*C*", +"temperature_min_02","temperature_min_02","WorldClim_2.1_BCC-CSM2-MR_ssp370_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Feb","min T Feb","february","degrees Celsius","*degree*C*", +"temperature_min_03","temperature_min_03","WorldClim_2.1_BCC-CSM2-MR_ssp370_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Mar","min T Mar","march","degrees Celsius","*degree*C*", +"temperature_min_04","temperature_min_04","WorldClim_2.1_BCC-CSM2-MR_ssp370_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Apr","min T Apr","april","degrees Celsius","*degree*C*", +"temperature_min_05","temperature_min_05","WorldClim_2.1_BCC-CSM2-MR_ssp370_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature May","min T May","may","degrees Celsius","*degree*C*", +"temperature_min_06","temperature_min_06","WorldClim_2.1_BCC-CSM2-MR_ssp370_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jun","min T Jun","june","degrees Celsius","*degree*C*", +"temperature_min_07","temperature_min_07","WorldClim_2.1_BCC-CSM2-MR_ssp370_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jul","min T Jul","july","degrees Celsius","*degree*C*", +"temperature_min_08","temperature_min_08","WorldClim_2.1_BCC-CSM2-MR_ssp370_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Aug","min T Aug","august","degrees Celsius","*degree*C*", +"temperature_min_09","temperature_min_09","WorldClim_2.1_BCC-CSM2-MR_ssp370_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Sep","min T Sep","september","degrees Celsius","*degree*C*", +"temperature_min_10","temperature_min_10","WorldClim_2.1_BCC-CSM2-MR_ssp370_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Oct","min T Oct","october","degrees Celsius","*degree*C*", +"temperature_min_11","temperature_min_11","WorldClim_2.1_BCC-CSM2-MR_ssp370_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Nov","min T Nov","november","degrees Celsius","*degree*C*", +"temperature_min_12","temperature_min_12","WorldClim_2.1_BCC-CSM2-MR_ssp370_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Dec","min T Dec","december","degrees Celsius","*degree*C*", +"temperature_max_01","temperature_max_01","WorldClim_2.1_BCC-CSM2-MR_ssp370_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jan","max T Jan","january","degrees Celsius","*degree*C*", +"temperature_max_02","temperature_max_02","WorldClim_2.1_BCC-CSM2-MR_ssp370_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Feb","max T Feb","february","degrees Celsius","*degree*C*", +"temperature_max_03","temperature_max_03","WorldClim_2.1_BCC-CSM2-MR_ssp370_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Mar","max T Mar","march","degrees Celsius","*degree*C*", +"temperature_max_04","temperature_max_04","WorldClim_2.1_BCC-CSM2-MR_ssp370_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Apr","max T Apr","april","degrees Celsius","*degree*C*", +"temperature_max_05","temperature_max_05","WorldClim_2.1_BCC-CSM2-MR_ssp370_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature May","max T May","may","degrees Celsius","*degree*C*", +"temperature_max_06","temperature_max_06","WorldClim_2.1_BCC-CSM2-MR_ssp370_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jun","max T Jun","june","degrees Celsius","*degree*C*", +"temperature_max_07","temperature_max_07","WorldClim_2.1_BCC-CSM2-MR_ssp370_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jul","max T Jul","july","degrees Celsius","*degree*C*", +"temperature_max_08","temperature_max_08","WorldClim_2.1_BCC-CSM2-MR_ssp370_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Aug","max T Aug","august","degrees Celsius","*degree*C*", +"temperature_max_09","temperature_max_09","WorldClim_2.1_BCC-CSM2-MR_ssp370_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Sep","max T Sep","september","degrees Celsius","*degree*C*", +"temperature_max_10","temperature_max_10","WorldClim_2.1_BCC-CSM2-MR_ssp370_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Oct","max T Oct","october","degrees Celsius","*degree*C*", +"temperature_max_11","temperature_max_11","WorldClim_2.1_BCC-CSM2-MR_ssp370_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Nov","max T Nov","november","degrees Celsius","*degree*C*", +"temperature_max_12","temperature_max_12","WorldClim_2.1_BCC-CSM2-MR_ssp370_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Dec","max T Dec","december","degrees Celsius","*degree*C*", +"bio01","bio01","WorldClim_2.1_BCC-CSM2-MR_ssp370_5m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual mean temperature","ann. mean T","year","degrees Celsius","*degree*C*", +"bio02","bio02","WorldClim_2.1_BCC-CSM2-MR_ssp370_5m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean diurnal range","diurn. range","year","degrees Celsius","*degree*C*", +"bio03","bio03","WorldClim_2.1_BCC-CSM2-MR_ssp370_5m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","isothermality","isothermality","year","","", +"bio04","bio04","WorldClim_2.1_BCC-CSM2-MR_ssp370_5m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature seasonality","T season.","year","degrees Celsius","*degree*C*", +"bio05","bio05","WorldClim_2.1_BCC-CSM2-MR_ssp370_5m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature of warmest month","max. T of warmest mo.","year","degrees Celsius","*degree*C*", +"bio06","bio06","WorldClim_2.1_BCC-CSM2-MR_ssp370_5m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature of coldest month","min. T of coldest mo.","year","degrees Celsius","*degree*C*", +"bio07","bio07","WorldClim_2.1_BCC-CSM2-MR_ssp370_5m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature annual range (bio05-bio06)","T ann. Range","year","degrees Celsius","*degree*C*", +"bio08","bio08","WorldClim_2.1_BCC-CSM2-MR_ssp370_5m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of wettest quarter","mean T of wettest qtr","year","degrees Celsius","*degree*C*", +"bio09","bio09","WorldClim_2.1_BCC-CSM2-MR_ssp370_5m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of driest quarter","mean T of driest qtr","year","degrees Celsius","*degree*C*", +"bio10","bio10","WorldClim_2.1_BCC-CSM2-MR_ssp370_5m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of warmest quarter","mean T of warmest qtr","year","degrees Celsius","*degree*C*", +"bio11","bio11","WorldClim_2.1_BCC-CSM2-MR_ssp370_5m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of coldest quarter","mean T of coldest qtr","year","degrees Celsius","*degree*C*", +"bio12","bio12","WorldClim_2.1_BCC-CSM2-MR_ssp370_5m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual precipitation","ann. P","year","mm per year","*mm~yr^-1*", +"bio13","bio13","WorldClim_2.1_BCC-CSM2-MR_ssp370_5m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest month","P of wettest mo.","year","mm per month","*mm~mo^-1*", +"bio14","bio14","WorldClim_2.1_BCC-CSM2-MR_ssp370_5m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest month","P of driest mo.","year","mm per month","*mm~mo^-1*", +"bio15","bio15","WorldClim_2.1_BCC-CSM2-MR_ssp370_5m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation seasonality (coeff var)","P season.","year","","", +"bio16","bio16","WorldClim_2.1_BCC-CSM2-MR_ssp370_5m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest quarter","P of wettest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio17","bio17","WorldClim_2.1_BCC-CSM2-MR_ssp370_5m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest quarter","P of driest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio18","bio18","WorldClim_2.1_BCC-CSM2-MR_ssp370_5m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of warmest quarter","P of warmest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio19","bio19","WorldClim_2.1_BCC-CSM2-MR_ssp370_5m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of coldest quarter","P of coldest qtr","year","mm per quarter","*mm~qtr^-1*", +"precipitation_01","precipitation_01","WorldClim_2.1_BCC-CSM2-MR_ssp370_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jan","P Jan","january","mm per month","*mm~mo^-1*", +"precipitation_02","precipitation_02","WorldClim_2.1_BCC-CSM2-MR_ssp370_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Feb","P Feb","february","mm per month","*mm~mo^-1*", +"precipitation_03","precipitation_03","WorldClim_2.1_BCC-CSM2-MR_ssp370_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Mar","P Mar","march","mm per month","*mm~mo^-1*", +"precipitation_04","precipitation_04","WorldClim_2.1_BCC-CSM2-MR_ssp370_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Apr","P Apr","april","mm per month","*mm~mo^-1*", +"precipitation_05","precipitation_05","WorldClim_2.1_BCC-CSM2-MR_ssp370_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation May","P May","may","mm per month","*mm~mo^-1*", +"precipitation_06","precipitation_06","WorldClim_2.1_BCC-CSM2-MR_ssp370_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jun","P Jun","june","mm per month","*mm~mo^-1*", +"precipitation_07","precipitation_07","WorldClim_2.1_BCC-CSM2-MR_ssp370_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jul","P Jul","july","mm per month","*mm~mo^-1*", +"precipitation_08","precipitation_08","WorldClim_2.1_BCC-CSM2-MR_ssp370_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Aug","P Aug","august","mm per month","*mm~mo^-1*", +"precipitation_09","precipitation_09","WorldClim_2.1_BCC-CSM2-MR_ssp370_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Sep","P Sep","september","mm per month","*mm~mo^-1*", +"precipitation_10","precipitation_10","WorldClim_2.1_BCC-CSM2-MR_ssp370_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Oct","P Oct","october","mm per month","*mm~mo^-1*", +"precipitation_11","precipitation_11","WorldClim_2.1_BCC-CSM2-MR_ssp370_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Nov","P Nov","november","mm per month","*mm~mo^-1*", +"precipitation_12","precipitation_12","WorldClim_2.1_BCC-CSM2-MR_ssp370_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Dec","P Dec","december","mm per month","*mm~mo^-1*", +"temperature_min_01","temperature_min_01","WorldClim_2.1_BCC-CSM2-MR_ssp370_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jan","min T Jan","january","degrees Celsius","*degree*C*", +"temperature_min_02","temperature_min_02","WorldClim_2.1_BCC-CSM2-MR_ssp370_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Feb","min T Feb","february","degrees Celsius","*degree*C*", +"temperature_min_03","temperature_min_03","WorldClim_2.1_BCC-CSM2-MR_ssp370_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Mar","min T Mar","march","degrees Celsius","*degree*C*", +"temperature_min_04","temperature_min_04","WorldClim_2.1_BCC-CSM2-MR_ssp370_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Apr","min T Apr","april","degrees Celsius","*degree*C*", +"temperature_min_05","temperature_min_05","WorldClim_2.1_BCC-CSM2-MR_ssp370_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature May","min T May","may","degrees Celsius","*degree*C*", +"temperature_min_06","temperature_min_06","WorldClim_2.1_BCC-CSM2-MR_ssp370_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jun","min T Jun","june","degrees Celsius","*degree*C*", +"temperature_min_07","temperature_min_07","WorldClim_2.1_BCC-CSM2-MR_ssp370_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jul","min T Jul","july","degrees Celsius","*degree*C*", +"temperature_min_08","temperature_min_08","WorldClim_2.1_BCC-CSM2-MR_ssp370_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Aug","min T Aug","august","degrees Celsius","*degree*C*", +"temperature_min_09","temperature_min_09","WorldClim_2.1_BCC-CSM2-MR_ssp370_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Sep","min T Sep","september","degrees Celsius","*degree*C*", +"temperature_min_10","temperature_min_10","WorldClim_2.1_BCC-CSM2-MR_ssp370_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Oct","min T Oct","october","degrees Celsius","*degree*C*", +"temperature_min_11","temperature_min_11","WorldClim_2.1_BCC-CSM2-MR_ssp370_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Nov","min T Nov","november","degrees Celsius","*degree*C*", +"temperature_min_12","temperature_min_12","WorldClim_2.1_BCC-CSM2-MR_ssp370_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Dec","min T Dec","december","degrees Celsius","*degree*C*", +"temperature_max_01","temperature_max_01","WorldClim_2.1_BCC-CSM2-MR_ssp370_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jan","max T Jan","january","degrees Celsius","*degree*C*", +"temperature_max_02","temperature_max_02","WorldClim_2.1_BCC-CSM2-MR_ssp370_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Feb","max T Feb","february","degrees Celsius","*degree*C*", +"temperature_max_03","temperature_max_03","WorldClim_2.1_BCC-CSM2-MR_ssp370_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Mar","max T Mar","march","degrees Celsius","*degree*C*", +"temperature_max_04","temperature_max_04","WorldClim_2.1_BCC-CSM2-MR_ssp370_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Apr","max T Apr","april","degrees Celsius","*degree*C*", +"temperature_max_05","temperature_max_05","WorldClim_2.1_BCC-CSM2-MR_ssp370_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature May","max T May","may","degrees Celsius","*degree*C*", +"temperature_max_06","temperature_max_06","WorldClim_2.1_BCC-CSM2-MR_ssp370_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jun","max T Jun","june","degrees Celsius","*degree*C*", +"temperature_max_07","temperature_max_07","WorldClim_2.1_BCC-CSM2-MR_ssp370_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jul","max T Jul","july","degrees Celsius","*degree*C*", +"temperature_max_08","temperature_max_08","WorldClim_2.1_BCC-CSM2-MR_ssp370_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Aug","max T Aug","august","degrees Celsius","*degree*C*", +"temperature_max_09","temperature_max_09","WorldClim_2.1_BCC-CSM2-MR_ssp370_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Sep","max T Sep","september","degrees Celsius","*degree*C*", +"temperature_max_10","temperature_max_10","WorldClim_2.1_BCC-CSM2-MR_ssp370_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Oct","max T Oct","october","degrees Celsius","*degree*C*", +"temperature_max_11","temperature_max_11","WorldClim_2.1_BCC-CSM2-MR_ssp370_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Nov","max T Nov","november","degrees Celsius","*degree*C*", +"temperature_max_12","temperature_max_12","WorldClim_2.1_BCC-CSM2-MR_ssp370_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Dec","max T Dec","december","degrees Celsius","*degree*C*", +"bio01","bio01","WorldClim_2.1_BCC-CSM2-MR_ssp585_10m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual mean temperature","ann. mean T","year","degrees Celsius","*degree*C*", +"bio02","bio02","WorldClim_2.1_BCC-CSM2-MR_ssp585_10m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean diurnal range","diurn. range","year","degrees Celsius","*degree*C*", +"bio03","bio03","WorldClim_2.1_BCC-CSM2-MR_ssp585_10m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","isothermality","isothermality","year","","", +"bio04","bio04","WorldClim_2.1_BCC-CSM2-MR_ssp585_10m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature seasonality","T season.","year","degrees Celsius","*degree*C*", +"bio05","bio05","WorldClim_2.1_BCC-CSM2-MR_ssp585_10m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature of warmest month","max. T of warmest mo.","year","degrees Celsius","*degree*C*", +"bio06","bio06","WorldClim_2.1_BCC-CSM2-MR_ssp585_10m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature of coldest month","min. T of coldest mo.","year","degrees Celsius","*degree*C*", +"bio07","bio07","WorldClim_2.1_BCC-CSM2-MR_ssp585_10m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature annual range (bio05-bio06)","T ann. Range","year","degrees Celsius","*degree*C*", +"bio08","bio08","WorldClim_2.1_BCC-CSM2-MR_ssp585_10m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of wettest quarter","mean T of wettest qtr","year","degrees Celsius","*degree*C*", +"bio09","bio09","WorldClim_2.1_BCC-CSM2-MR_ssp585_10m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of driest quarter","mean T of driest qtr","year","degrees Celsius","*degree*C*", +"bio10","bio10","WorldClim_2.1_BCC-CSM2-MR_ssp585_10m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of warmest quarter","mean T of warmest qtr","year","degrees Celsius","*degree*C*", +"bio11","bio11","WorldClim_2.1_BCC-CSM2-MR_ssp585_10m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of coldest quarter","mean T of coldest qtr","year","degrees Celsius","*degree*C*", +"bio12","bio12","WorldClim_2.1_BCC-CSM2-MR_ssp585_10m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual precipitation","ann. P","year","mm per year","*mm~yr^-1*", +"bio13","bio13","WorldClim_2.1_BCC-CSM2-MR_ssp585_10m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest month","P of wettest mo.","year","mm per month","*mm~mo^-1*", +"bio14","bio14","WorldClim_2.1_BCC-CSM2-MR_ssp585_10m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest month","P of driest mo.","year","mm per month","*mm~mo^-1*", +"bio15","bio15","WorldClim_2.1_BCC-CSM2-MR_ssp585_10m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation seasonality (coeff var)","P season.","year","","", +"bio16","bio16","WorldClim_2.1_BCC-CSM2-MR_ssp585_10m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest quarter","P of wettest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio17","bio17","WorldClim_2.1_BCC-CSM2-MR_ssp585_10m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest quarter","P of driest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio18","bio18","WorldClim_2.1_BCC-CSM2-MR_ssp585_10m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of warmest quarter","P of warmest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio19","bio19","WorldClim_2.1_BCC-CSM2-MR_ssp585_10m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of coldest quarter","P of coldest qtr","year","mm per quarter","*mm~qtr^-1*", +"precipitation_01","precipitation_01","WorldClim_2.1_BCC-CSM2-MR_ssp585_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jan","P Jan","january","mm per month","*mm~mo^-1*", +"precipitation_02","precipitation_02","WorldClim_2.1_BCC-CSM2-MR_ssp585_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Feb","P Feb","february","mm per month","*mm~mo^-1*", +"precipitation_03","precipitation_03","WorldClim_2.1_BCC-CSM2-MR_ssp585_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Mar","P Mar","march","mm per month","*mm~mo^-1*", +"precipitation_04","precipitation_04","WorldClim_2.1_BCC-CSM2-MR_ssp585_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Apr","P Apr","april","mm per month","*mm~mo^-1*", +"precipitation_05","precipitation_05","WorldClim_2.1_BCC-CSM2-MR_ssp585_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation May","P May","may","mm per month","*mm~mo^-1*", +"precipitation_06","precipitation_06","WorldClim_2.1_BCC-CSM2-MR_ssp585_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jun","P Jun","june","mm per month","*mm~mo^-1*", +"precipitation_07","precipitation_07","WorldClim_2.1_BCC-CSM2-MR_ssp585_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jul","P Jul","july","mm per month","*mm~mo^-1*", +"precipitation_08","precipitation_08","WorldClim_2.1_BCC-CSM2-MR_ssp585_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Aug","P Aug","august","mm per month","*mm~mo^-1*", +"precipitation_09","precipitation_09","WorldClim_2.1_BCC-CSM2-MR_ssp585_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Sep","P Sep","september","mm per month","*mm~mo^-1*", +"precipitation_10","precipitation_10","WorldClim_2.1_BCC-CSM2-MR_ssp585_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Oct","P Oct","october","mm per month","*mm~mo^-1*", +"precipitation_11","precipitation_11","WorldClim_2.1_BCC-CSM2-MR_ssp585_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Nov","P Nov","november","mm per month","*mm~mo^-1*", +"precipitation_12","precipitation_12","WorldClim_2.1_BCC-CSM2-MR_ssp585_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Dec","P Dec","december","mm per month","*mm~mo^-1*", +"temperature_min_01","temperature_min_01","WorldClim_2.1_BCC-CSM2-MR_ssp585_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jan","min T Jan","january","degrees Celsius","*degree*C*", +"temperature_min_02","temperature_min_02","WorldClim_2.1_BCC-CSM2-MR_ssp585_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Feb","min T Feb","february","degrees Celsius","*degree*C*", +"temperature_min_03","temperature_min_03","WorldClim_2.1_BCC-CSM2-MR_ssp585_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Mar","min T Mar","march","degrees Celsius","*degree*C*", +"temperature_min_04","temperature_min_04","WorldClim_2.1_BCC-CSM2-MR_ssp585_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Apr","min T Apr","april","degrees Celsius","*degree*C*", +"temperature_min_05","temperature_min_05","WorldClim_2.1_BCC-CSM2-MR_ssp585_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature May","min T May","may","degrees Celsius","*degree*C*", +"temperature_min_06","temperature_min_06","WorldClim_2.1_BCC-CSM2-MR_ssp585_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jun","min T Jun","june","degrees Celsius","*degree*C*", +"temperature_min_07","temperature_min_07","WorldClim_2.1_BCC-CSM2-MR_ssp585_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jul","min T Jul","july","degrees Celsius","*degree*C*", +"temperature_min_08","temperature_min_08","WorldClim_2.1_BCC-CSM2-MR_ssp585_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Aug","min T Aug","august","degrees Celsius","*degree*C*", +"temperature_min_09","temperature_min_09","WorldClim_2.1_BCC-CSM2-MR_ssp585_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Sep","min T Sep","september","degrees Celsius","*degree*C*", +"temperature_min_10","temperature_min_10","WorldClim_2.1_BCC-CSM2-MR_ssp585_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Oct","min T Oct","october","degrees Celsius","*degree*C*", +"temperature_min_11","temperature_min_11","WorldClim_2.1_BCC-CSM2-MR_ssp585_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Nov","min T Nov","november","degrees Celsius","*degree*C*", +"temperature_min_12","temperature_min_12","WorldClim_2.1_BCC-CSM2-MR_ssp585_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Dec","min T Dec","december","degrees Celsius","*degree*C*", +"temperature_max_01","temperature_max_01","WorldClim_2.1_BCC-CSM2-MR_ssp585_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jan","max T Jan","january","degrees Celsius","*degree*C*", +"temperature_max_02","temperature_max_02","WorldClim_2.1_BCC-CSM2-MR_ssp585_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Feb","max T Feb","february","degrees Celsius","*degree*C*", +"temperature_max_03","temperature_max_03","WorldClim_2.1_BCC-CSM2-MR_ssp585_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Mar","max T Mar","march","degrees Celsius","*degree*C*", +"temperature_max_04","temperature_max_04","WorldClim_2.1_BCC-CSM2-MR_ssp585_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Apr","max T Apr","april","degrees Celsius","*degree*C*", +"temperature_max_05","temperature_max_05","WorldClim_2.1_BCC-CSM2-MR_ssp585_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature May","max T May","may","degrees Celsius","*degree*C*", +"temperature_max_06","temperature_max_06","WorldClim_2.1_BCC-CSM2-MR_ssp585_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jun","max T Jun","june","degrees Celsius","*degree*C*", +"temperature_max_07","temperature_max_07","WorldClim_2.1_BCC-CSM2-MR_ssp585_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jul","max T Jul","july","degrees Celsius","*degree*C*", +"temperature_max_08","temperature_max_08","WorldClim_2.1_BCC-CSM2-MR_ssp585_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Aug","max T Aug","august","degrees Celsius","*degree*C*", +"temperature_max_09","temperature_max_09","WorldClim_2.1_BCC-CSM2-MR_ssp585_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Sep","max T Sep","september","degrees Celsius","*degree*C*", +"temperature_max_10","temperature_max_10","WorldClim_2.1_BCC-CSM2-MR_ssp585_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Oct","max T Oct","october","degrees Celsius","*degree*C*", +"temperature_max_11","temperature_max_11","WorldClim_2.1_BCC-CSM2-MR_ssp585_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Nov","max T Nov","november","degrees Celsius","*degree*C*", +"temperature_max_12","temperature_max_12","WorldClim_2.1_BCC-CSM2-MR_ssp585_10m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Dec","max T Dec","december","degrees Celsius","*degree*C*", +"bio01","bio01","WorldClim_2.1_BCC-CSM2-MR_ssp585_5m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual mean temperature","ann. mean T","year","degrees Celsius","*degree*C*", +"bio02","bio02","WorldClim_2.1_BCC-CSM2-MR_ssp585_5m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean diurnal range","diurn. range","year","degrees Celsius","*degree*C*", +"bio03","bio03","WorldClim_2.1_BCC-CSM2-MR_ssp585_5m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","isothermality","isothermality","year","","", +"bio04","bio04","WorldClim_2.1_BCC-CSM2-MR_ssp585_5m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature seasonality","T season.","year","degrees Celsius","*degree*C*", +"bio05","bio05","WorldClim_2.1_BCC-CSM2-MR_ssp585_5m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature of warmest month","max. T of warmest mo.","year","degrees Celsius","*degree*C*", +"bio06","bio06","WorldClim_2.1_BCC-CSM2-MR_ssp585_5m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature of coldest month","min. T of coldest mo.","year","degrees Celsius","*degree*C*", +"bio07","bio07","WorldClim_2.1_BCC-CSM2-MR_ssp585_5m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature annual range (bio05-bio06)","T ann. Range","year","degrees Celsius","*degree*C*", +"bio08","bio08","WorldClim_2.1_BCC-CSM2-MR_ssp585_5m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of wettest quarter","mean T of wettest qtr","year","degrees Celsius","*degree*C*", +"bio09","bio09","WorldClim_2.1_BCC-CSM2-MR_ssp585_5m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of driest quarter","mean T of driest qtr","year","degrees Celsius","*degree*C*", +"bio10","bio10","WorldClim_2.1_BCC-CSM2-MR_ssp585_5m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of warmest quarter","mean T of warmest qtr","year","degrees Celsius","*degree*C*", +"bio11","bio11","WorldClim_2.1_BCC-CSM2-MR_ssp585_5m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of coldest quarter","mean T of coldest qtr","year","degrees Celsius","*degree*C*", +"bio12","bio12","WorldClim_2.1_BCC-CSM2-MR_ssp585_5m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual precipitation","ann. P","year","mm per year","*mm~yr^-1*", +"bio13","bio13","WorldClim_2.1_BCC-CSM2-MR_ssp585_5m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest month","P of wettest mo.","year","mm per month","*mm~mo^-1*", +"bio14","bio14","WorldClim_2.1_BCC-CSM2-MR_ssp585_5m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest month","P of driest mo.","year","mm per month","*mm~mo^-1*", +"bio15","bio15","WorldClim_2.1_BCC-CSM2-MR_ssp585_5m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation seasonality (coeff var)","P season.","year","","", +"bio16","bio16","WorldClim_2.1_BCC-CSM2-MR_ssp585_5m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest quarter","P of wettest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio17","bio17","WorldClim_2.1_BCC-CSM2-MR_ssp585_5m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest quarter","P of driest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio18","bio18","WorldClim_2.1_BCC-CSM2-MR_ssp585_5m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of warmest quarter","P of warmest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio19","bio19","WorldClim_2.1_BCC-CSM2-MR_ssp585_5m",FALSE,"WorldClim_2.1_BCC-CSM2-MR_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of coldest quarter","P of coldest qtr","year","mm per quarter","*mm~qtr^-1*", +"precipitation_01","precipitation_01","WorldClim_2.1_BCC-CSM2-MR_ssp585_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jan","P Jan","january","mm per month","*mm~mo^-1*", +"precipitation_02","precipitation_02","WorldClim_2.1_BCC-CSM2-MR_ssp585_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Feb","P Feb","february","mm per month","*mm~mo^-1*", +"precipitation_03","precipitation_03","WorldClim_2.1_BCC-CSM2-MR_ssp585_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Mar","P Mar","march","mm per month","*mm~mo^-1*", +"precipitation_04","precipitation_04","WorldClim_2.1_BCC-CSM2-MR_ssp585_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Apr","P Apr","april","mm per month","*mm~mo^-1*", +"precipitation_05","precipitation_05","WorldClim_2.1_BCC-CSM2-MR_ssp585_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation May","P May","may","mm per month","*mm~mo^-1*", +"precipitation_06","precipitation_06","WorldClim_2.1_BCC-CSM2-MR_ssp585_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jun","P Jun","june","mm per month","*mm~mo^-1*", +"precipitation_07","precipitation_07","WorldClim_2.1_BCC-CSM2-MR_ssp585_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jul","P Jul","july","mm per month","*mm~mo^-1*", +"precipitation_08","precipitation_08","WorldClim_2.1_BCC-CSM2-MR_ssp585_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Aug","P Aug","august","mm per month","*mm~mo^-1*", +"precipitation_09","precipitation_09","WorldClim_2.1_BCC-CSM2-MR_ssp585_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Sep","P Sep","september","mm per month","*mm~mo^-1*", +"precipitation_10","precipitation_10","WorldClim_2.1_BCC-CSM2-MR_ssp585_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Oct","P Oct","october","mm per month","*mm~mo^-1*", +"precipitation_11","precipitation_11","WorldClim_2.1_BCC-CSM2-MR_ssp585_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Nov","P Nov","november","mm per month","*mm~mo^-1*", +"precipitation_12","precipitation_12","WorldClim_2.1_BCC-CSM2-MR_ssp585_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Dec","P Dec","december","mm per month","*mm~mo^-1*", +"temperature_min_01","temperature_min_01","WorldClim_2.1_BCC-CSM2-MR_ssp585_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jan","min T Jan","january","degrees Celsius","*degree*C*", +"temperature_min_02","temperature_min_02","WorldClim_2.1_BCC-CSM2-MR_ssp585_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Feb","min T Feb","february","degrees Celsius","*degree*C*", +"temperature_min_03","temperature_min_03","WorldClim_2.1_BCC-CSM2-MR_ssp585_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Mar","min T Mar","march","degrees Celsius","*degree*C*", +"temperature_min_04","temperature_min_04","WorldClim_2.1_BCC-CSM2-MR_ssp585_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Apr","min T Apr","april","degrees Celsius","*degree*C*", +"temperature_min_05","temperature_min_05","WorldClim_2.1_BCC-CSM2-MR_ssp585_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature May","min T May","may","degrees Celsius","*degree*C*", +"temperature_min_06","temperature_min_06","WorldClim_2.1_BCC-CSM2-MR_ssp585_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jun","min T Jun","june","degrees Celsius","*degree*C*", +"temperature_min_07","temperature_min_07","WorldClim_2.1_BCC-CSM2-MR_ssp585_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jul","min T Jul","july","degrees Celsius","*degree*C*", +"temperature_min_08","temperature_min_08","WorldClim_2.1_BCC-CSM2-MR_ssp585_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Aug","min T Aug","august","degrees Celsius","*degree*C*", +"temperature_min_09","temperature_min_09","WorldClim_2.1_BCC-CSM2-MR_ssp585_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Sep","min T Sep","september","degrees Celsius","*degree*C*", +"temperature_min_10","temperature_min_10","WorldClim_2.1_BCC-CSM2-MR_ssp585_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Oct","min T Oct","october","degrees Celsius","*degree*C*", +"temperature_min_11","temperature_min_11","WorldClim_2.1_BCC-CSM2-MR_ssp585_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Nov","min T Nov","november","degrees Celsius","*degree*C*", +"temperature_min_12","temperature_min_12","WorldClim_2.1_BCC-CSM2-MR_ssp585_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Dec","min T Dec","december","degrees Celsius","*degree*C*", +"temperature_max_01","temperature_max_01","WorldClim_2.1_BCC-CSM2-MR_ssp585_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jan","max T Jan","january","degrees Celsius","*degree*C*", +"temperature_max_02","temperature_max_02","WorldClim_2.1_BCC-CSM2-MR_ssp585_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Feb","max T Feb","february","degrees Celsius","*degree*C*", +"temperature_max_03","temperature_max_03","WorldClim_2.1_BCC-CSM2-MR_ssp585_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Mar","max T Mar","march","degrees Celsius","*degree*C*", +"temperature_max_04","temperature_max_04","WorldClim_2.1_BCC-CSM2-MR_ssp585_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Apr","max T Apr","april","degrees Celsius","*degree*C*", +"temperature_max_05","temperature_max_05","WorldClim_2.1_BCC-CSM2-MR_ssp585_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature May","max T May","may","degrees Celsius","*degree*C*", +"temperature_max_06","temperature_max_06","WorldClim_2.1_BCC-CSM2-MR_ssp585_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jun","max T Jun","june","degrees Celsius","*degree*C*", +"temperature_max_07","temperature_max_07","WorldClim_2.1_BCC-CSM2-MR_ssp585_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jul","max T Jul","july","degrees Celsius","*degree*C*", +"temperature_max_08","temperature_max_08","WorldClim_2.1_BCC-CSM2-MR_ssp585_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Aug","max T Aug","august","degrees Celsius","*degree*C*", +"temperature_max_09","temperature_max_09","WorldClim_2.1_BCC-CSM2-MR_ssp585_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Sep","max T Sep","september","degrees Celsius","*degree*C*", +"temperature_max_10","temperature_max_10","WorldClim_2.1_BCC-CSM2-MR_ssp585_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Oct","max T Oct","october","degrees Celsius","*degree*C*", +"temperature_max_11","temperature_max_11","WorldClim_2.1_BCC-CSM2-MR_ssp585_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Nov","max T Nov","november","degrees Celsius","*degree*C*", +"temperature_max_12","temperature_max_12","WorldClim_2.1_BCC-CSM2-MR_ssp585_5m",TRUE,"WorldClim_2.1_BCC-CSM2-MR_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Dec","max T Dec","december","degrees Celsius","*degree*C*", +"bio01","bio01","WorldClim_2.1_CMCC-ESM2_ssp126_10m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual mean temperature","ann. mean T","year","degrees Celsius","*degree*C*", +"bio02","bio02","WorldClim_2.1_CMCC-ESM2_ssp126_10m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean diurnal range","diurn. range","year","degrees Celsius","*degree*C*", +"bio03","bio03","WorldClim_2.1_CMCC-ESM2_ssp126_10m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","isothermality","isothermality","year","","", +"bio04","bio04","WorldClim_2.1_CMCC-ESM2_ssp126_10m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature seasonality","T season.","year","degrees Celsius","*degree*C*", +"bio05","bio05","WorldClim_2.1_CMCC-ESM2_ssp126_10m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature of warmest month","max. T of warmest mo.","year","degrees Celsius","*degree*C*", +"bio06","bio06","WorldClim_2.1_CMCC-ESM2_ssp126_10m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature of coldest month","min. T of coldest mo.","year","degrees Celsius","*degree*C*", +"bio07","bio07","WorldClim_2.1_CMCC-ESM2_ssp126_10m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature annual range (bio05-bio06)","T ann. Range","year","degrees Celsius","*degree*C*", +"bio08","bio08","WorldClim_2.1_CMCC-ESM2_ssp126_10m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of wettest quarter","mean T of wettest qtr","year","degrees Celsius","*degree*C*", +"bio09","bio09","WorldClim_2.1_CMCC-ESM2_ssp126_10m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of driest quarter","mean T of driest qtr","year","degrees Celsius","*degree*C*", +"bio10","bio10","WorldClim_2.1_CMCC-ESM2_ssp126_10m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of warmest quarter","mean T of warmest qtr","year","degrees Celsius","*degree*C*", +"bio11","bio11","WorldClim_2.1_CMCC-ESM2_ssp126_10m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of coldest quarter","mean T of coldest qtr","year","degrees Celsius","*degree*C*", +"bio12","bio12","WorldClim_2.1_CMCC-ESM2_ssp126_10m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual precipitation","ann. P","year","mm per year","*mm~yr^-1*", +"bio13","bio13","WorldClim_2.1_CMCC-ESM2_ssp126_10m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest month","P of wettest mo.","year","mm per month","*mm~mo^-1*", +"bio14","bio14","WorldClim_2.1_CMCC-ESM2_ssp126_10m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest month","P of driest mo.","year","mm per month","*mm~mo^-1*", +"bio15","bio15","WorldClim_2.1_CMCC-ESM2_ssp126_10m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation seasonality (coeff var)","P season.","year","","", +"bio16","bio16","WorldClim_2.1_CMCC-ESM2_ssp126_10m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest quarter","P of wettest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio17","bio17","WorldClim_2.1_CMCC-ESM2_ssp126_10m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest quarter","P of driest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio18","bio18","WorldClim_2.1_CMCC-ESM2_ssp126_10m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of warmest quarter","P of warmest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio19","bio19","WorldClim_2.1_CMCC-ESM2_ssp126_10m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of coldest quarter","P of coldest qtr","year","mm per quarter","*mm~qtr^-1*", +"precipitation_01","precipitation_01","WorldClim_2.1_CMCC-ESM2_ssp126_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jan","P Jan","january","mm per month","*mm~mo^-1*", +"precipitation_02","precipitation_02","WorldClim_2.1_CMCC-ESM2_ssp126_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Feb","P Feb","february","mm per month","*mm~mo^-1*", +"precipitation_03","precipitation_03","WorldClim_2.1_CMCC-ESM2_ssp126_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Mar","P Mar","march","mm per month","*mm~mo^-1*", +"precipitation_04","precipitation_04","WorldClim_2.1_CMCC-ESM2_ssp126_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Apr","P Apr","april","mm per month","*mm~mo^-1*", +"precipitation_05","precipitation_05","WorldClim_2.1_CMCC-ESM2_ssp126_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation May","P May","may","mm per month","*mm~mo^-1*", +"precipitation_06","precipitation_06","WorldClim_2.1_CMCC-ESM2_ssp126_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jun","P Jun","june","mm per month","*mm~mo^-1*", +"precipitation_07","precipitation_07","WorldClim_2.1_CMCC-ESM2_ssp126_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jul","P Jul","july","mm per month","*mm~mo^-1*", +"precipitation_08","precipitation_08","WorldClim_2.1_CMCC-ESM2_ssp126_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Aug","P Aug","august","mm per month","*mm~mo^-1*", +"precipitation_09","precipitation_09","WorldClim_2.1_CMCC-ESM2_ssp126_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Sep","P Sep","september","mm per month","*mm~mo^-1*", +"precipitation_10","precipitation_10","WorldClim_2.1_CMCC-ESM2_ssp126_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Oct","P Oct","october","mm per month","*mm~mo^-1*", +"precipitation_11","precipitation_11","WorldClim_2.1_CMCC-ESM2_ssp126_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Nov","P Nov","november","mm per month","*mm~mo^-1*", +"precipitation_12","precipitation_12","WorldClim_2.1_CMCC-ESM2_ssp126_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Dec","P Dec","december","mm per month","*mm~mo^-1*", +"temperature_min_01","temperature_min_01","WorldClim_2.1_CMCC-ESM2_ssp126_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jan","min T Jan","january","degrees Celsius","*degree*C*", +"temperature_min_02","temperature_min_02","WorldClim_2.1_CMCC-ESM2_ssp126_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Feb","min T Feb","february","degrees Celsius","*degree*C*", +"temperature_min_03","temperature_min_03","WorldClim_2.1_CMCC-ESM2_ssp126_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Mar","min T Mar","march","degrees Celsius","*degree*C*", +"temperature_min_04","temperature_min_04","WorldClim_2.1_CMCC-ESM2_ssp126_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Apr","min T Apr","april","degrees Celsius","*degree*C*", +"temperature_min_05","temperature_min_05","WorldClim_2.1_CMCC-ESM2_ssp126_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature May","min T May","may","degrees Celsius","*degree*C*", +"temperature_min_06","temperature_min_06","WorldClim_2.1_CMCC-ESM2_ssp126_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jun","min T Jun","june","degrees Celsius","*degree*C*", +"temperature_min_07","temperature_min_07","WorldClim_2.1_CMCC-ESM2_ssp126_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jul","min T Jul","july","degrees Celsius","*degree*C*", +"temperature_min_08","temperature_min_08","WorldClim_2.1_CMCC-ESM2_ssp126_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Aug","min T Aug","august","degrees Celsius","*degree*C*", +"temperature_min_09","temperature_min_09","WorldClim_2.1_CMCC-ESM2_ssp126_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Sep","min T Sep","september","degrees Celsius","*degree*C*", +"temperature_min_10","temperature_min_10","WorldClim_2.1_CMCC-ESM2_ssp126_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Oct","min T Oct","october","degrees Celsius","*degree*C*", +"temperature_min_11","temperature_min_11","WorldClim_2.1_CMCC-ESM2_ssp126_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Nov","min T Nov","november","degrees Celsius","*degree*C*", +"temperature_min_12","temperature_min_12","WorldClim_2.1_CMCC-ESM2_ssp126_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Dec","min T Dec","december","degrees Celsius","*degree*C*", +"temperature_max_01","temperature_max_01","WorldClim_2.1_CMCC-ESM2_ssp126_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jan","max T Jan","january","degrees Celsius","*degree*C*", +"temperature_max_02","temperature_max_02","WorldClim_2.1_CMCC-ESM2_ssp126_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Feb","max T Feb","february","degrees Celsius","*degree*C*", +"temperature_max_03","temperature_max_03","WorldClim_2.1_CMCC-ESM2_ssp126_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Mar","max T Mar","march","degrees Celsius","*degree*C*", +"temperature_max_04","temperature_max_04","WorldClim_2.1_CMCC-ESM2_ssp126_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Apr","max T Apr","april","degrees Celsius","*degree*C*", +"temperature_max_05","temperature_max_05","WorldClim_2.1_CMCC-ESM2_ssp126_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature May","max T May","may","degrees Celsius","*degree*C*", +"temperature_max_06","temperature_max_06","WorldClim_2.1_CMCC-ESM2_ssp126_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jun","max T Jun","june","degrees Celsius","*degree*C*", +"temperature_max_07","temperature_max_07","WorldClim_2.1_CMCC-ESM2_ssp126_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jul","max T Jul","july","degrees Celsius","*degree*C*", +"temperature_max_08","temperature_max_08","WorldClim_2.1_CMCC-ESM2_ssp126_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Aug","max T Aug","august","degrees Celsius","*degree*C*", +"temperature_max_09","temperature_max_09","WorldClim_2.1_CMCC-ESM2_ssp126_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Sep","max T Sep","september","degrees Celsius","*degree*C*", +"temperature_max_10","temperature_max_10","WorldClim_2.1_CMCC-ESM2_ssp126_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Oct","max T Oct","october","degrees Celsius","*degree*C*", +"temperature_max_11","temperature_max_11","WorldClim_2.1_CMCC-ESM2_ssp126_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Nov","max T Nov","november","degrees Celsius","*degree*C*", +"temperature_max_12","temperature_max_12","WorldClim_2.1_CMCC-ESM2_ssp126_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Dec","max T Dec","december","degrees Celsius","*degree*C*", +"bio01","bio01","WorldClim_2.1_CMCC-ESM2_ssp126_5m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual mean temperature","ann. mean T","year","degrees Celsius","*degree*C*", +"bio02","bio02","WorldClim_2.1_CMCC-ESM2_ssp126_5m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean diurnal range","diurn. range","year","degrees Celsius","*degree*C*", +"bio03","bio03","WorldClim_2.1_CMCC-ESM2_ssp126_5m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","isothermality","isothermality","year","","", +"bio04","bio04","WorldClim_2.1_CMCC-ESM2_ssp126_5m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature seasonality","T season.","year","degrees Celsius","*degree*C*", +"bio05","bio05","WorldClim_2.1_CMCC-ESM2_ssp126_5m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature of warmest month","max. T of warmest mo.","year","degrees Celsius","*degree*C*", +"bio06","bio06","WorldClim_2.1_CMCC-ESM2_ssp126_5m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature of coldest month","min. T of coldest mo.","year","degrees Celsius","*degree*C*", +"bio07","bio07","WorldClim_2.1_CMCC-ESM2_ssp126_5m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature annual range (bio05-bio06)","T ann. Range","year","degrees Celsius","*degree*C*", +"bio08","bio08","WorldClim_2.1_CMCC-ESM2_ssp126_5m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of wettest quarter","mean T of wettest qtr","year","degrees Celsius","*degree*C*", +"bio09","bio09","WorldClim_2.1_CMCC-ESM2_ssp126_5m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of driest quarter","mean T of driest qtr","year","degrees Celsius","*degree*C*", +"bio10","bio10","WorldClim_2.1_CMCC-ESM2_ssp126_5m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of warmest quarter","mean T of warmest qtr","year","degrees Celsius","*degree*C*", +"bio11","bio11","WorldClim_2.1_CMCC-ESM2_ssp126_5m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of coldest quarter","mean T of coldest qtr","year","degrees Celsius","*degree*C*", +"bio12","bio12","WorldClim_2.1_CMCC-ESM2_ssp126_5m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual precipitation","ann. P","year","mm per year","*mm~yr^-1*", +"bio13","bio13","WorldClim_2.1_CMCC-ESM2_ssp126_5m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest month","P of wettest mo.","year","mm per month","*mm~mo^-1*", +"bio14","bio14","WorldClim_2.1_CMCC-ESM2_ssp126_5m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest month","P of driest mo.","year","mm per month","*mm~mo^-1*", +"bio15","bio15","WorldClim_2.1_CMCC-ESM2_ssp126_5m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation seasonality (coeff var)","P season.","year","","", +"bio16","bio16","WorldClim_2.1_CMCC-ESM2_ssp126_5m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest quarter","P of wettest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio17","bio17","WorldClim_2.1_CMCC-ESM2_ssp126_5m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest quarter","P of driest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio18","bio18","WorldClim_2.1_CMCC-ESM2_ssp126_5m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of warmest quarter","P of warmest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio19","bio19","WorldClim_2.1_CMCC-ESM2_ssp126_5m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of coldest quarter","P of coldest qtr","year","mm per quarter","*mm~qtr^-1*", +"precipitation_01","precipitation_01","WorldClim_2.1_CMCC-ESM2_ssp126_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jan","P Jan","january","mm per month","*mm~mo^-1*", +"precipitation_02","precipitation_02","WorldClim_2.1_CMCC-ESM2_ssp126_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Feb","P Feb","february","mm per month","*mm~mo^-1*", +"precipitation_03","precipitation_03","WorldClim_2.1_CMCC-ESM2_ssp126_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Mar","P Mar","march","mm per month","*mm~mo^-1*", +"precipitation_04","precipitation_04","WorldClim_2.1_CMCC-ESM2_ssp126_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Apr","P Apr","april","mm per month","*mm~mo^-1*", +"precipitation_05","precipitation_05","WorldClim_2.1_CMCC-ESM2_ssp126_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation May","P May","may","mm per month","*mm~mo^-1*", +"precipitation_06","precipitation_06","WorldClim_2.1_CMCC-ESM2_ssp126_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jun","P Jun","june","mm per month","*mm~mo^-1*", +"precipitation_07","precipitation_07","WorldClim_2.1_CMCC-ESM2_ssp126_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jul","P Jul","july","mm per month","*mm~mo^-1*", +"precipitation_08","precipitation_08","WorldClim_2.1_CMCC-ESM2_ssp126_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Aug","P Aug","august","mm per month","*mm~mo^-1*", +"precipitation_09","precipitation_09","WorldClim_2.1_CMCC-ESM2_ssp126_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Sep","P Sep","september","mm per month","*mm~mo^-1*", +"precipitation_10","precipitation_10","WorldClim_2.1_CMCC-ESM2_ssp126_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Oct","P Oct","october","mm per month","*mm~mo^-1*", +"precipitation_11","precipitation_11","WorldClim_2.1_CMCC-ESM2_ssp126_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Nov","P Nov","november","mm per month","*mm~mo^-1*", +"precipitation_12","precipitation_12","WorldClim_2.1_CMCC-ESM2_ssp126_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Dec","P Dec","december","mm per month","*mm~mo^-1*", +"temperature_min_01","temperature_min_01","WorldClim_2.1_CMCC-ESM2_ssp126_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jan","min T Jan","january","degrees Celsius","*degree*C*", +"temperature_min_02","temperature_min_02","WorldClim_2.1_CMCC-ESM2_ssp126_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Feb","min T Feb","february","degrees Celsius","*degree*C*", +"temperature_min_03","temperature_min_03","WorldClim_2.1_CMCC-ESM2_ssp126_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Mar","min T Mar","march","degrees Celsius","*degree*C*", +"temperature_min_04","temperature_min_04","WorldClim_2.1_CMCC-ESM2_ssp126_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Apr","min T Apr","april","degrees Celsius","*degree*C*", +"temperature_min_05","temperature_min_05","WorldClim_2.1_CMCC-ESM2_ssp126_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature May","min T May","may","degrees Celsius","*degree*C*", +"temperature_min_06","temperature_min_06","WorldClim_2.1_CMCC-ESM2_ssp126_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jun","min T Jun","june","degrees Celsius","*degree*C*", +"temperature_min_07","temperature_min_07","WorldClim_2.1_CMCC-ESM2_ssp126_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jul","min T Jul","july","degrees Celsius","*degree*C*", +"temperature_min_08","temperature_min_08","WorldClim_2.1_CMCC-ESM2_ssp126_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Aug","min T Aug","august","degrees Celsius","*degree*C*", +"temperature_min_09","temperature_min_09","WorldClim_2.1_CMCC-ESM2_ssp126_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Sep","min T Sep","september","degrees Celsius","*degree*C*", +"temperature_min_10","temperature_min_10","WorldClim_2.1_CMCC-ESM2_ssp126_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Oct","min T Oct","october","degrees Celsius","*degree*C*", +"temperature_min_11","temperature_min_11","WorldClim_2.1_CMCC-ESM2_ssp126_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Nov","min T Nov","november","degrees Celsius","*degree*C*", +"temperature_min_12","temperature_min_12","WorldClim_2.1_CMCC-ESM2_ssp126_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Dec","min T Dec","december","degrees Celsius","*degree*C*", +"temperature_max_01","temperature_max_01","WorldClim_2.1_CMCC-ESM2_ssp126_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jan","max T Jan","january","degrees Celsius","*degree*C*", +"temperature_max_02","temperature_max_02","WorldClim_2.1_CMCC-ESM2_ssp126_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Feb","max T Feb","february","degrees Celsius","*degree*C*", +"temperature_max_03","temperature_max_03","WorldClim_2.1_CMCC-ESM2_ssp126_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Mar","max T Mar","march","degrees Celsius","*degree*C*", +"temperature_max_04","temperature_max_04","WorldClim_2.1_CMCC-ESM2_ssp126_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Apr","max T Apr","april","degrees Celsius","*degree*C*", +"temperature_max_05","temperature_max_05","WorldClim_2.1_CMCC-ESM2_ssp126_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature May","max T May","may","degrees Celsius","*degree*C*", +"temperature_max_06","temperature_max_06","WorldClim_2.1_CMCC-ESM2_ssp126_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jun","max T Jun","june","degrees Celsius","*degree*C*", +"temperature_max_07","temperature_max_07","WorldClim_2.1_CMCC-ESM2_ssp126_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jul","max T Jul","july","degrees Celsius","*degree*C*", +"temperature_max_08","temperature_max_08","WorldClim_2.1_CMCC-ESM2_ssp126_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Aug","max T Aug","august","degrees Celsius","*degree*C*", +"temperature_max_09","temperature_max_09","WorldClim_2.1_CMCC-ESM2_ssp126_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Sep","max T Sep","september","degrees Celsius","*degree*C*", +"temperature_max_10","temperature_max_10","WorldClim_2.1_CMCC-ESM2_ssp126_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Oct","max T Oct","october","degrees Celsius","*degree*C*", +"temperature_max_11","temperature_max_11","WorldClim_2.1_CMCC-ESM2_ssp126_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Nov","max T Nov","november","degrees Celsius","*degree*C*", +"temperature_max_12","temperature_max_12","WorldClim_2.1_CMCC-ESM2_ssp126_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Dec","max T Dec","december","degrees Celsius","*degree*C*", +"bio01","bio01","WorldClim_2.1_CMCC-ESM2_ssp245_10m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual mean temperature","ann. mean T","year","degrees Celsius","*degree*C*", +"bio02","bio02","WorldClim_2.1_CMCC-ESM2_ssp245_10m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean diurnal range","diurn. range","year","degrees Celsius","*degree*C*", +"bio03","bio03","WorldClim_2.1_CMCC-ESM2_ssp245_10m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","isothermality","isothermality","year","","", +"bio04","bio04","WorldClim_2.1_CMCC-ESM2_ssp245_10m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature seasonality","T season.","year","degrees Celsius","*degree*C*", +"bio05","bio05","WorldClim_2.1_CMCC-ESM2_ssp245_10m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature of warmest month","max. T of warmest mo.","year","degrees Celsius","*degree*C*", +"bio06","bio06","WorldClim_2.1_CMCC-ESM2_ssp245_10m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature of coldest month","min. T of coldest mo.","year","degrees Celsius","*degree*C*", +"bio07","bio07","WorldClim_2.1_CMCC-ESM2_ssp245_10m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature annual range (bio05-bio06)","T ann. Range","year","degrees Celsius","*degree*C*", +"bio08","bio08","WorldClim_2.1_CMCC-ESM2_ssp245_10m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of wettest quarter","mean T of wettest qtr","year","degrees Celsius","*degree*C*", +"bio09","bio09","WorldClim_2.1_CMCC-ESM2_ssp245_10m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of driest quarter","mean T of driest qtr","year","degrees Celsius","*degree*C*", +"bio10","bio10","WorldClim_2.1_CMCC-ESM2_ssp245_10m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of warmest quarter","mean T of warmest qtr","year","degrees Celsius","*degree*C*", +"bio11","bio11","WorldClim_2.1_CMCC-ESM2_ssp245_10m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of coldest quarter","mean T of coldest qtr","year","degrees Celsius","*degree*C*", +"bio12","bio12","WorldClim_2.1_CMCC-ESM2_ssp245_10m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual precipitation","ann. P","year","mm per year","*mm~yr^-1*", +"bio13","bio13","WorldClim_2.1_CMCC-ESM2_ssp245_10m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest month","P of wettest mo.","year","mm per month","*mm~mo^-1*", +"bio14","bio14","WorldClim_2.1_CMCC-ESM2_ssp245_10m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest month","P of driest mo.","year","mm per month","*mm~mo^-1*", +"bio15","bio15","WorldClim_2.1_CMCC-ESM2_ssp245_10m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation seasonality (coeff var)","P season.","year","","", +"bio16","bio16","WorldClim_2.1_CMCC-ESM2_ssp245_10m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest quarter","P of wettest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio17","bio17","WorldClim_2.1_CMCC-ESM2_ssp245_10m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest quarter","P of driest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio18","bio18","WorldClim_2.1_CMCC-ESM2_ssp245_10m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of warmest quarter","P of warmest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio19","bio19","WorldClim_2.1_CMCC-ESM2_ssp245_10m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of coldest quarter","P of coldest qtr","year","mm per quarter","*mm~qtr^-1*", +"precipitation_01","precipitation_01","WorldClim_2.1_CMCC-ESM2_ssp245_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jan","P Jan","january","mm per month","*mm~mo^-1*", +"precipitation_02","precipitation_02","WorldClim_2.1_CMCC-ESM2_ssp245_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Feb","P Feb","february","mm per month","*mm~mo^-1*", +"precipitation_03","precipitation_03","WorldClim_2.1_CMCC-ESM2_ssp245_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Mar","P Mar","march","mm per month","*mm~mo^-1*", +"precipitation_04","precipitation_04","WorldClim_2.1_CMCC-ESM2_ssp245_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Apr","P Apr","april","mm per month","*mm~mo^-1*", +"precipitation_05","precipitation_05","WorldClim_2.1_CMCC-ESM2_ssp245_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation May","P May","may","mm per month","*mm~mo^-1*", +"precipitation_06","precipitation_06","WorldClim_2.1_CMCC-ESM2_ssp245_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jun","P Jun","june","mm per month","*mm~mo^-1*", +"precipitation_07","precipitation_07","WorldClim_2.1_CMCC-ESM2_ssp245_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jul","P Jul","july","mm per month","*mm~mo^-1*", +"precipitation_08","precipitation_08","WorldClim_2.1_CMCC-ESM2_ssp245_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Aug","P Aug","august","mm per month","*mm~mo^-1*", +"precipitation_09","precipitation_09","WorldClim_2.1_CMCC-ESM2_ssp245_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Sep","P Sep","september","mm per month","*mm~mo^-1*", +"precipitation_10","precipitation_10","WorldClim_2.1_CMCC-ESM2_ssp245_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Oct","P Oct","october","mm per month","*mm~mo^-1*", +"precipitation_11","precipitation_11","WorldClim_2.1_CMCC-ESM2_ssp245_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Nov","P Nov","november","mm per month","*mm~mo^-1*", +"precipitation_12","precipitation_12","WorldClim_2.1_CMCC-ESM2_ssp245_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Dec","P Dec","december","mm per month","*mm~mo^-1*", +"temperature_min_01","temperature_min_01","WorldClim_2.1_CMCC-ESM2_ssp245_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jan","min T Jan","january","degrees Celsius","*degree*C*", +"temperature_min_02","temperature_min_02","WorldClim_2.1_CMCC-ESM2_ssp245_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Feb","min T Feb","february","degrees Celsius","*degree*C*", +"temperature_min_03","temperature_min_03","WorldClim_2.1_CMCC-ESM2_ssp245_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Mar","min T Mar","march","degrees Celsius","*degree*C*", +"temperature_min_04","temperature_min_04","WorldClim_2.1_CMCC-ESM2_ssp245_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Apr","min T Apr","april","degrees Celsius","*degree*C*", +"temperature_min_05","temperature_min_05","WorldClim_2.1_CMCC-ESM2_ssp245_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature May","min T May","may","degrees Celsius","*degree*C*", +"temperature_min_06","temperature_min_06","WorldClim_2.1_CMCC-ESM2_ssp245_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jun","min T Jun","june","degrees Celsius","*degree*C*", +"temperature_min_07","temperature_min_07","WorldClim_2.1_CMCC-ESM2_ssp245_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jul","min T Jul","july","degrees Celsius","*degree*C*", +"temperature_min_08","temperature_min_08","WorldClim_2.1_CMCC-ESM2_ssp245_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Aug","min T Aug","august","degrees Celsius","*degree*C*", +"temperature_min_09","temperature_min_09","WorldClim_2.1_CMCC-ESM2_ssp245_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Sep","min T Sep","september","degrees Celsius","*degree*C*", +"temperature_min_10","temperature_min_10","WorldClim_2.1_CMCC-ESM2_ssp245_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Oct","min T Oct","october","degrees Celsius","*degree*C*", +"temperature_min_11","temperature_min_11","WorldClim_2.1_CMCC-ESM2_ssp245_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Nov","min T Nov","november","degrees Celsius","*degree*C*", +"temperature_min_12","temperature_min_12","WorldClim_2.1_CMCC-ESM2_ssp245_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Dec","min T Dec","december","degrees Celsius","*degree*C*", +"temperature_max_01","temperature_max_01","WorldClim_2.1_CMCC-ESM2_ssp245_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jan","max T Jan","january","degrees Celsius","*degree*C*", +"temperature_max_02","temperature_max_02","WorldClim_2.1_CMCC-ESM2_ssp245_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Feb","max T Feb","february","degrees Celsius","*degree*C*", +"temperature_max_03","temperature_max_03","WorldClim_2.1_CMCC-ESM2_ssp245_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Mar","max T Mar","march","degrees Celsius","*degree*C*", +"temperature_max_04","temperature_max_04","WorldClim_2.1_CMCC-ESM2_ssp245_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Apr","max T Apr","april","degrees Celsius","*degree*C*", +"temperature_max_05","temperature_max_05","WorldClim_2.1_CMCC-ESM2_ssp245_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature May","max T May","may","degrees Celsius","*degree*C*", +"temperature_max_06","temperature_max_06","WorldClim_2.1_CMCC-ESM2_ssp245_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jun","max T Jun","june","degrees Celsius","*degree*C*", +"temperature_max_07","temperature_max_07","WorldClim_2.1_CMCC-ESM2_ssp245_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jul","max T Jul","july","degrees Celsius","*degree*C*", +"temperature_max_08","temperature_max_08","WorldClim_2.1_CMCC-ESM2_ssp245_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Aug","max T Aug","august","degrees Celsius","*degree*C*", +"temperature_max_09","temperature_max_09","WorldClim_2.1_CMCC-ESM2_ssp245_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Sep","max T Sep","september","degrees Celsius","*degree*C*", +"temperature_max_10","temperature_max_10","WorldClim_2.1_CMCC-ESM2_ssp245_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Oct","max T Oct","october","degrees Celsius","*degree*C*", +"temperature_max_11","temperature_max_11","WorldClim_2.1_CMCC-ESM2_ssp245_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Nov","max T Nov","november","degrees Celsius","*degree*C*", +"temperature_max_12","temperature_max_12","WorldClim_2.1_CMCC-ESM2_ssp245_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Dec","max T Dec","december","degrees Celsius","*degree*C*", +"bio01","bio01","WorldClim_2.1_CMCC-ESM2_ssp245_5m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual mean temperature","ann. mean T","year","degrees Celsius","*degree*C*", +"bio02","bio02","WorldClim_2.1_CMCC-ESM2_ssp245_5m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean diurnal range","diurn. range","year","degrees Celsius","*degree*C*", +"bio03","bio03","WorldClim_2.1_CMCC-ESM2_ssp245_5m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","isothermality","isothermality","year","","", +"bio04","bio04","WorldClim_2.1_CMCC-ESM2_ssp245_5m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature seasonality","T season.","year","degrees Celsius","*degree*C*", +"bio05","bio05","WorldClim_2.1_CMCC-ESM2_ssp245_5m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature of warmest month","max. T of warmest mo.","year","degrees Celsius","*degree*C*", +"bio06","bio06","WorldClim_2.1_CMCC-ESM2_ssp245_5m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature of coldest month","min. T of coldest mo.","year","degrees Celsius","*degree*C*", +"bio07","bio07","WorldClim_2.1_CMCC-ESM2_ssp245_5m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature annual range (bio05-bio06)","T ann. Range","year","degrees Celsius","*degree*C*", +"bio08","bio08","WorldClim_2.1_CMCC-ESM2_ssp245_5m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of wettest quarter","mean T of wettest qtr","year","degrees Celsius","*degree*C*", +"bio09","bio09","WorldClim_2.1_CMCC-ESM2_ssp245_5m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of driest quarter","mean T of driest qtr","year","degrees Celsius","*degree*C*", +"bio10","bio10","WorldClim_2.1_CMCC-ESM2_ssp245_5m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of warmest quarter","mean T of warmest qtr","year","degrees Celsius","*degree*C*", +"bio11","bio11","WorldClim_2.1_CMCC-ESM2_ssp245_5m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of coldest quarter","mean T of coldest qtr","year","degrees Celsius","*degree*C*", +"bio12","bio12","WorldClim_2.1_CMCC-ESM2_ssp245_5m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual precipitation","ann. P","year","mm per year","*mm~yr^-1*", +"bio13","bio13","WorldClim_2.1_CMCC-ESM2_ssp245_5m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest month","P of wettest mo.","year","mm per month","*mm~mo^-1*", +"bio14","bio14","WorldClim_2.1_CMCC-ESM2_ssp245_5m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest month","P of driest mo.","year","mm per month","*mm~mo^-1*", +"bio15","bio15","WorldClim_2.1_CMCC-ESM2_ssp245_5m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation seasonality (coeff var)","P season.","year","","", +"bio16","bio16","WorldClim_2.1_CMCC-ESM2_ssp245_5m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest quarter","P of wettest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio17","bio17","WorldClim_2.1_CMCC-ESM2_ssp245_5m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest quarter","P of driest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio18","bio18","WorldClim_2.1_CMCC-ESM2_ssp245_5m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of warmest quarter","P of warmest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio19","bio19","WorldClim_2.1_CMCC-ESM2_ssp245_5m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of coldest quarter","P of coldest qtr","year","mm per quarter","*mm~qtr^-1*", +"precipitation_01","precipitation_01","WorldClim_2.1_CMCC-ESM2_ssp245_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jan","P Jan","january","mm per month","*mm~mo^-1*", +"precipitation_02","precipitation_02","WorldClim_2.1_CMCC-ESM2_ssp245_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Feb","P Feb","february","mm per month","*mm~mo^-1*", +"precipitation_03","precipitation_03","WorldClim_2.1_CMCC-ESM2_ssp245_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Mar","P Mar","march","mm per month","*mm~mo^-1*", +"precipitation_04","precipitation_04","WorldClim_2.1_CMCC-ESM2_ssp245_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Apr","P Apr","april","mm per month","*mm~mo^-1*", +"precipitation_05","precipitation_05","WorldClim_2.1_CMCC-ESM2_ssp245_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation May","P May","may","mm per month","*mm~mo^-1*", +"precipitation_06","precipitation_06","WorldClim_2.1_CMCC-ESM2_ssp245_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jun","P Jun","june","mm per month","*mm~mo^-1*", +"precipitation_07","precipitation_07","WorldClim_2.1_CMCC-ESM2_ssp245_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jul","P Jul","july","mm per month","*mm~mo^-1*", +"precipitation_08","precipitation_08","WorldClim_2.1_CMCC-ESM2_ssp245_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Aug","P Aug","august","mm per month","*mm~mo^-1*", +"precipitation_09","precipitation_09","WorldClim_2.1_CMCC-ESM2_ssp245_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Sep","P Sep","september","mm per month","*mm~mo^-1*", +"precipitation_10","precipitation_10","WorldClim_2.1_CMCC-ESM2_ssp245_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Oct","P Oct","october","mm per month","*mm~mo^-1*", +"precipitation_11","precipitation_11","WorldClim_2.1_CMCC-ESM2_ssp245_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Nov","P Nov","november","mm per month","*mm~mo^-1*", +"precipitation_12","precipitation_12","WorldClim_2.1_CMCC-ESM2_ssp245_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Dec","P Dec","december","mm per month","*mm~mo^-1*", +"temperature_min_01","temperature_min_01","WorldClim_2.1_CMCC-ESM2_ssp245_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jan","min T Jan","january","degrees Celsius","*degree*C*", +"temperature_min_02","temperature_min_02","WorldClim_2.1_CMCC-ESM2_ssp245_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Feb","min T Feb","february","degrees Celsius","*degree*C*", +"temperature_min_03","temperature_min_03","WorldClim_2.1_CMCC-ESM2_ssp245_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Mar","min T Mar","march","degrees Celsius","*degree*C*", +"temperature_min_04","temperature_min_04","WorldClim_2.1_CMCC-ESM2_ssp245_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Apr","min T Apr","april","degrees Celsius","*degree*C*", +"temperature_min_05","temperature_min_05","WorldClim_2.1_CMCC-ESM2_ssp245_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature May","min T May","may","degrees Celsius","*degree*C*", +"temperature_min_06","temperature_min_06","WorldClim_2.1_CMCC-ESM2_ssp245_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jun","min T Jun","june","degrees Celsius","*degree*C*", +"temperature_min_07","temperature_min_07","WorldClim_2.1_CMCC-ESM2_ssp245_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jul","min T Jul","july","degrees Celsius","*degree*C*", +"temperature_min_08","temperature_min_08","WorldClim_2.1_CMCC-ESM2_ssp245_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Aug","min T Aug","august","degrees Celsius","*degree*C*", +"temperature_min_09","temperature_min_09","WorldClim_2.1_CMCC-ESM2_ssp245_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Sep","min T Sep","september","degrees Celsius","*degree*C*", +"temperature_min_10","temperature_min_10","WorldClim_2.1_CMCC-ESM2_ssp245_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Oct","min T Oct","october","degrees Celsius","*degree*C*", +"temperature_min_11","temperature_min_11","WorldClim_2.1_CMCC-ESM2_ssp245_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Nov","min T Nov","november","degrees Celsius","*degree*C*", +"temperature_min_12","temperature_min_12","WorldClim_2.1_CMCC-ESM2_ssp245_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Dec","min T Dec","december","degrees Celsius","*degree*C*", +"temperature_max_01","temperature_max_01","WorldClim_2.1_CMCC-ESM2_ssp245_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jan","max T Jan","january","degrees Celsius","*degree*C*", +"temperature_max_02","temperature_max_02","WorldClim_2.1_CMCC-ESM2_ssp245_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Feb","max T Feb","february","degrees Celsius","*degree*C*", +"temperature_max_03","temperature_max_03","WorldClim_2.1_CMCC-ESM2_ssp245_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Mar","max T Mar","march","degrees Celsius","*degree*C*", +"temperature_max_04","temperature_max_04","WorldClim_2.1_CMCC-ESM2_ssp245_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Apr","max T Apr","april","degrees Celsius","*degree*C*", +"temperature_max_05","temperature_max_05","WorldClim_2.1_CMCC-ESM2_ssp245_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature May","max T May","may","degrees Celsius","*degree*C*", +"temperature_max_06","temperature_max_06","WorldClim_2.1_CMCC-ESM2_ssp245_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jun","max T Jun","june","degrees Celsius","*degree*C*", +"temperature_max_07","temperature_max_07","WorldClim_2.1_CMCC-ESM2_ssp245_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jul","max T Jul","july","degrees Celsius","*degree*C*", +"temperature_max_08","temperature_max_08","WorldClim_2.1_CMCC-ESM2_ssp245_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Aug","max T Aug","august","degrees Celsius","*degree*C*", +"temperature_max_09","temperature_max_09","WorldClim_2.1_CMCC-ESM2_ssp245_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Sep","max T Sep","september","degrees Celsius","*degree*C*", +"temperature_max_10","temperature_max_10","WorldClim_2.1_CMCC-ESM2_ssp245_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Oct","max T Oct","october","degrees Celsius","*degree*C*", +"temperature_max_11","temperature_max_11","WorldClim_2.1_CMCC-ESM2_ssp245_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Nov","max T Nov","november","degrees Celsius","*degree*C*", +"temperature_max_12","temperature_max_12","WorldClim_2.1_CMCC-ESM2_ssp245_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Dec","max T Dec","december","degrees Celsius","*degree*C*", +"bio01","bio01","WorldClim_2.1_CMCC-ESM2_ssp370_10m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual mean temperature","ann. mean T","year","degrees Celsius","*degree*C*", +"bio02","bio02","WorldClim_2.1_CMCC-ESM2_ssp370_10m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean diurnal range","diurn. range","year","degrees Celsius","*degree*C*", +"bio03","bio03","WorldClim_2.1_CMCC-ESM2_ssp370_10m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","isothermality","isothermality","year","","", +"bio04","bio04","WorldClim_2.1_CMCC-ESM2_ssp370_10m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature seasonality","T season.","year","degrees Celsius","*degree*C*", +"bio05","bio05","WorldClim_2.1_CMCC-ESM2_ssp370_10m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature of warmest month","max. T of warmest mo.","year","degrees Celsius","*degree*C*", +"bio06","bio06","WorldClim_2.1_CMCC-ESM2_ssp370_10m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature of coldest month","min. T of coldest mo.","year","degrees Celsius","*degree*C*", +"bio07","bio07","WorldClim_2.1_CMCC-ESM2_ssp370_10m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature annual range (bio05-bio06)","T ann. Range","year","degrees Celsius","*degree*C*", +"bio08","bio08","WorldClim_2.1_CMCC-ESM2_ssp370_10m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of wettest quarter","mean T of wettest qtr","year","degrees Celsius","*degree*C*", +"bio09","bio09","WorldClim_2.1_CMCC-ESM2_ssp370_10m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of driest quarter","mean T of driest qtr","year","degrees Celsius","*degree*C*", +"bio10","bio10","WorldClim_2.1_CMCC-ESM2_ssp370_10m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of warmest quarter","mean T of warmest qtr","year","degrees Celsius","*degree*C*", +"bio11","bio11","WorldClim_2.1_CMCC-ESM2_ssp370_10m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of coldest quarter","mean T of coldest qtr","year","degrees Celsius","*degree*C*", +"bio12","bio12","WorldClim_2.1_CMCC-ESM2_ssp370_10m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual precipitation","ann. P","year","mm per year","*mm~yr^-1*", +"bio13","bio13","WorldClim_2.1_CMCC-ESM2_ssp370_10m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest month","P of wettest mo.","year","mm per month","*mm~mo^-1*", +"bio14","bio14","WorldClim_2.1_CMCC-ESM2_ssp370_10m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest month","P of driest mo.","year","mm per month","*mm~mo^-1*", +"bio15","bio15","WorldClim_2.1_CMCC-ESM2_ssp370_10m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation seasonality (coeff var)","P season.","year","","", +"bio16","bio16","WorldClim_2.1_CMCC-ESM2_ssp370_10m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest quarter","P of wettest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio17","bio17","WorldClim_2.1_CMCC-ESM2_ssp370_10m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest quarter","P of driest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio18","bio18","WorldClim_2.1_CMCC-ESM2_ssp370_10m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of warmest quarter","P of warmest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio19","bio19","WorldClim_2.1_CMCC-ESM2_ssp370_10m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of coldest quarter","P of coldest qtr","year","mm per quarter","*mm~qtr^-1*", +"precipitation_01","precipitation_01","WorldClim_2.1_CMCC-ESM2_ssp370_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jan","P Jan","january","mm per month","*mm~mo^-1*", +"precipitation_02","precipitation_02","WorldClim_2.1_CMCC-ESM2_ssp370_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Feb","P Feb","february","mm per month","*mm~mo^-1*", +"precipitation_03","precipitation_03","WorldClim_2.1_CMCC-ESM2_ssp370_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Mar","P Mar","march","mm per month","*mm~mo^-1*", +"precipitation_04","precipitation_04","WorldClim_2.1_CMCC-ESM2_ssp370_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Apr","P Apr","april","mm per month","*mm~mo^-1*", +"precipitation_05","precipitation_05","WorldClim_2.1_CMCC-ESM2_ssp370_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation May","P May","may","mm per month","*mm~mo^-1*", +"precipitation_06","precipitation_06","WorldClim_2.1_CMCC-ESM2_ssp370_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jun","P Jun","june","mm per month","*mm~mo^-1*", +"precipitation_07","precipitation_07","WorldClim_2.1_CMCC-ESM2_ssp370_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jul","P Jul","july","mm per month","*mm~mo^-1*", +"precipitation_08","precipitation_08","WorldClim_2.1_CMCC-ESM2_ssp370_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Aug","P Aug","august","mm per month","*mm~mo^-1*", +"precipitation_09","precipitation_09","WorldClim_2.1_CMCC-ESM2_ssp370_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Sep","P Sep","september","mm per month","*mm~mo^-1*", +"precipitation_10","precipitation_10","WorldClim_2.1_CMCC-ESM2_ssp370_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Oct","P Oct","october","mm per month","*mm~mo^-1*", +"precipitation_11","precipitation_11","WorldClim_2.1_CMCC-ESM2_ssp370_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Nov","P Nov","november","mm per month","*mm~mo^-1*", +"precipitation_12","precipitation_12","WorldClim_2.1_CMCC-ESM2_ssp370_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Dec","P Dec","december","mm per month","*mm~mo^-1*", +"temperature_min_01","temperature_min_01","WorldClim_2.1_CMCC-ESM2_ssp370_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jan","min T Jan","january","degrees Celsius","*degree*C*", +"temperature_min_02","temperature_min_02","WorldClim_2.1_CMCC-ESM2_ssp370_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Feb","min T Feb","february","degrees Celsius","*degree*C*", +"temperature_min_03","temperature_min_03","WorldClim_2.1_CMCC-ESM2_ssp370_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Mar","min T Mar","march","degrees Celsius","*degree*C*", +"temperature_min_04","temperature_min_04","WorldClim_2.1_CMCC-ESM2_ssp370_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Apr","min T Apr","april","degrees Celsius","*degree*C*", +"temperature_min_05","temperature_min_05","WorldClim_2.1_CMCC-ESM2_ssp370_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature May","min T May","may","degrees Celsius","*degree*C*", +"temperature_min_06","temperature_min_06","WorldClim_2.1_CMCC-ESM2_ssp370_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jun","min T Jun","june","degrees Celsius","*degree*C*", +"temperature_min_07","temperature_min_07","WorldClim_2.1_CMCC-ESM2_ssp370_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jul","min T Jul","july","degrees Celsius","*degree*C*", +"temperature_min_08","temperature_min_08","WorldClim_2.1_CMCC-ESM2_ssp370_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Aug","min T Aug","august","degrees Celsius","*degree*C*", +"temperature_min_09","temperature_min_09","WorldClim_2.1_CMCC-ESM2_ssp370_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Sep","min T Sep","september","degrees Celsius","*degree*C*", +"temperature_min_10","temperature_min_10","WorldClim_2.1_CMCC-ESM2_ssp370_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Oct","min T Oct","october","degrees Celsius","*degree*C*", +"temperature_min_11","temperature_min_11","WorldClim_2.1_CMCC-ESM2_ssp370_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Nov","min T Nov","november","degrees Celsius","*degree*C*", +"temperature_min_12","temperature_min_12","WorldClim_2.1_CMCC-ESM2_ssp370_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Dec","min T Dec","december","degrees Celsius","*degree*C*", +"temperature_max_01","temperature_max_01","WorldClim_2.1_CMCC-ESM2_ssp370_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jan","max T Jan","january","degrees Celsius","*degree*C*", +"temperature_max_02","temperature_max_02","WorldClim_2.1_CMCC-ESM2_ssp370_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Feb","max T Feb","february","degrees Celsius","*degree*C*", +"temperature_max_03","temperature_max_03","WorldClim_2.1_CMCC-ESM2_ssp370_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Mar","max T Mar","march","degrees Celsius","*degree*C*", +"temperature_max_04","temperature_max_04","WorldClim_2.1_CMCC-ESM2_ssp370_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Apr","max T Apr","april","degrees Celsius","*degree*C*", +"temperature_max_05","temperature_max_05","WorldClim_2.1_CMCC-ESM2_ssp370_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature May","max T May","may","degrees Celsius","*degree*C*", +"temperature_max_06","temperature_max_06","WorldClim_2.1_CMCC-ESM2_ssp370_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jun","max T Jun","june","degrees Celsius","*degree*C*", +"temperature_max_07","temperature_max_07","WorldClim_2.1_CMCC-ESM2_ssp370_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jul","max T Jul","july","degrees Celsius","*degree*C*", +"temperature_max_08","temperature_max_08","WorldClim_2.1_CMCC-ESM2_ssp370_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Aug","max T Aug","august","degrees Celsius","*degree*C*", +"temperature_max_09","temperature_max_09","WorldClim_2.1_CMCC-ESM2_ssp370_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Sep","max T Sep","september","degrees Celsius","*degree*C*", +"temperature_max_10","temperature_max_10","WorldClim_2.1_CMCC-ESM2_ssp370_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Oct","max T Oct","october","degrees Celsius","*degree*C*", +"temperature_max_11","temperature_max_11","WorldClim_2.1_CMCC-ESM2_ssp370_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Nov","max T Nov","november","degrees Celsius","*degree*C*", +"temperature_max_12","temperature_max_12","WorldClim_2.1_CMCC-ESM2_ssp370_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Dec","max T Dec","december","degrees Celsius","*degree*C*", +"bio01","bio01","WorldClim_2.1_CMCC-ESM2_ssp370_5m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual mean temperature","ann. mean T","year","degrees Celsius","*degree*C*", +"bio02","bio02","WorldClim_2.1_CMCC-ESM2_ssp370_5m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean diurnal range","diurn. range","year","degrees Celsius","*degree*C*", +"bio03","bio03","WorldClim_2.1_CMCC-ESM2_ssp370_5m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","isothermality","isothermality","year","","", +"bio04","bio04","WorldClim_2.1_CMCC-ESM2_ssp370_5m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature seasonality","T season.","year","degrees Celsius","*degree*C*", +"bio05","bio05","WorldClim_2.1_CMCC-ESM2_ssp370_5m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature of warmest month","max. T of warmest mo.","year","degrees Celsius","*degree*C*", +"bio06","bio06","WorldClim_2.1_CMCC-ESM2_ssp370_5m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature of coldest month","min. T of coldest mo.","year","degrees Celsius","*degree*C*", +"bio07","bio07","WorldClim_2.1_CMCC-ESM2_ssp370_5m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature annual range (bio05-bio06)","T ann. Range","year","degrees Celsius","*degree*C*", +"bio08","bio08","WorldClim_2.1_CMCC-ESM2_ssp370_5m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of wettest quarter","mean T of wettest qtr","year","degrees Celsius","*degree*C*", +"bio09","bio09","WorldClim_2.1_CMCC-ESM2_ssp370_5m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of driest quarter","mean T of driest qtr","year","degrees Celsius","*degree*C*", +"bio10","bio10","WorldClim_2.1_CMCC-ESM2_ssp370_5m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of warmest quarter","mean T of warmest qtr","year","degrees Celsius","*degree*C*", +"bio11","bio11","WorldClim_2.1_CMCC-ESM2_ssp370_5m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of coldest quarter","mean T of coldest qtr","year","degrees Celsius","*degree*C*", +"bio12","bio12","WorldClim_2.1_CMCC-ESM2_ssp370_5m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual precipitation","ann. P","year","mm per year","*mm~yr^-1*", +"bio13","bio13","WorldClim_2.1_CMCC-ESM2_ssp370_5m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest month","P of wettest mo.","year","mm per month","*mm~mo^-1*", +"bio14","bio14","WorldClim_2.1_CMCC-ESM2_ssp370_5m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest month","P of driest mo.","year","mm per month","*mm~mo^-1*", +"bio15","bio15","WorldClim_2.1_CMCC-ESM2_ssp370_5m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation seasonality (coeff var)","P season.","year","","", +"bio16","bio16","WorldClim_2.1_CMCC-ESM2_ssp370_5m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest quarter","P of wettest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio17","bio17","WorldClim_2.1_CMCC-ESM2_ssp370_5m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest quarter","P of driest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio18","bio18","WorldClim_2.1_CMCC-ESM2_ssp370_5m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of warmest quarter","P of warmest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio19","bio19","WorldClim_2.1_CMCC-ESM2_ssp370_5m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of coldest quarter","P of coldest qtr","year","mm per quarter","*mm~qtr^-1*", +"precipitation_01","precipitation_01","WorldClim_2.1_CMCC-ESM2_ssp370_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jan","P Jan","january","mm per month","*mm~mo^-1*", +"precipitation_02","precipitation_02","WorldClim_2.1_CMCC-ESM2_ssp370_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Feb","P Feb","february","mm per month","*mm~mo^-1*", +"precipitation_03","precipitation_03","WorldClim_2.1_CMCC-ESM2_ssp370_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Mar","P Mar","march","mm per month","*mm~mo^-1*", +"precipitation_04","precipitation_04","WorldClim_2.1_CMCC-ESM2_ssp370_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Apr","P Apr","april","mm per month","*mm~mo^-1*", +"precipitation_05","precipitation_05","WorldClim_2.1_CMCC-ESM2_ssp370_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation May","P May","may","mm per month","*mm~mo^-1*", +"precipitation_06","precipitation_06","WorldClim_2.1_CMCC-ESM2_ssp370_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jun","P Jun","june","mm per month","*mm~mo^-1*", +"precipitation_07","precipitation_07","WorldClim_2.1_CMCC-ESM2_ssp370_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jul","P Jul","july","mm per month","*mm~mo^-1*", +"precipitation_08","precipitation_08","WorldClim_2.1_CMCC-ESM2_ssp370_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Aug","P Aug","august","mm per month","*mm~mo^-1*", +"precipitation_09","precipitation_09","WorldClim_2.1_CMCC-ESM2_ssp370_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Sep","P Sep","september","mm per month","*mm~mo^-1*", +"precipitation_10","precipitation_10","WorldClim_2.1_CMCC-ESM2_ssp370_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Oct","P Oct","october","mm per month","*mm~mo^-1*", +"precipitation_11","precipitation_11","WorldClim_2.1_CMCC-ESM2_ssp370_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Nov","P Nov","november","mm per month","*mm~mo^-1*", +"precipitation_12","precipitation_12","WorldClim_2.1_CMCC-ESM2_ssp370_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Dec","P Dec","december","mm per month","*mm~mo^-1*", +"temperature_min_01","temperature_min_01","WorldClim_2.1_CMCC-ESM2_ssp370_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jan","min T Jan","january","degrees Celsius","*degree*C*", +"temperature_min_02","temperature_min_02","WorldClim_2.1_CMCC-ESM2_ssp370_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Feb","min T Feb","february","degrees Celsius","*degree*C*", +"temperature_min_03","temperature_min_03","WorldClim_2.1_CMCC-ESM2_ssp370_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Mar","min T Mar","march","degrees Celsius","*degree*C*", +"temperature_min_04","temperature_min_04","WorldClim_2.1_CMCC-ESM2_ssp370_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Apr","min T Apr","april","degrees Celsius","*degree*C*", +"temperature_min_05","temperature_min_05","WorldClim_2.1_CMCC-ESM2_ssp370_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature May","min T May","may","degrees Celsius","*degree*C*", +"temperature_min_06","temperature_min_06","WorldClim_2.1_CMCC-ESM2_ssp370_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jun","min T Jun","june","degrees Celsius","*degree*C*", +"temperature_min_07","temperature_min_07","WorldClim_2.1_CMCC-ESM2_ssp370_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jul","min T Jul","july","degrees Celsius","*degree*C*", +"temperature_min_08","temperature_min_08","WorldClim_2.1_CMCC-ESM2_ssp370_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Aug","min T Aug","august","degrees Celsius","*degree*C*", +"temperature_min_09","temperature_min_09","WorldClim_2.1_CMCC-ESM2_ssp370_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Sep","min T Sep","september","degrees Celsius","*degree*C*", +"temperature_min_10","temperature_min_10","WorldClim_2.1_CMCC-ESM2_ssp370_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Oct","min T Oct","october","degrees Celsius","*degree*C*", +"temperature_min_11","temperature_min_11","WorldClim_2.1_CMCC-ESM2_ssp370_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Nov","min T Nov","november","degrees Celsius","*degree*C*", +"temperature_min_12","temperature_min_12","WorldClim_2.1_CMCC-ESM2_ssp370_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Dec","min T Dec","december","degrees Celsius","*degree*C*", +"temperature_max_01","temperature_max_01","WorldClim_2.1_CMCC-ESM2_ssp370_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jan","max T Jan","january","degrees Celsius","*degree*C*", +"temperature_max_02","temperature_max_02","WorldClim_2.1_CMCC-ESM2_ssp370_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Feb","max T Feb","february","degrees Celsius","*degree*C*", +"temperature_max_03","temperature_max_03","WorldClim_2.1_CMCC-ESM2_ssp370_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Mar","max T Mar","march","degrees Celsius","*degree*C*", +"temperature_max_04","temperature_max_04","WorldClim_2.1_CMCC-ESM2_ssp370_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Apr","max T Apr","april","degrees Celsius","*degree*C*", +"temperature_max_05","temperature_max_05","WorldClim_2.1_CMCC-ESM2_ssp370_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature May","max T May","may","degrees Celsius","*degree*C*", +"temperature_max_06","temperature_max_06","WorldClim_2.1_CMCC-ESM2_ssp370_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jun","max T Jun","june","degrees Celsius","*degree*C*", +"temperature_max_07","temperature_max_07","WorldClim_2.1_CMCC-ESM2_ssp370_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jul","max T Jul","july","degrees Celsius","*degree*C*", +"temperature_max_08","temperature_max_08","WorldClim_2.1_CMCC-ESM2_ssp370_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Aug","max T Aug","august","degrees Celsius","*degree*C*", +"temperature_max_09","temperature_max_09","WorldClim_2.1_CMCC-ESM2_ssp370_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Sep","max T Sep","september","degrees Celsius","*degree*C*", +"temperature_max_10","temperature_max_10","WorldClim_2.1_CMCC-ESM2_ssp370_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Oct","max T Oct","october","degrees Celsius","*degree*C*", +"temperature_max_11","temperature_max_11","WorldClim_2.1_CMCC-ESM2_ssp370_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Nov","max T Nov","november","degrees Celsius","*degree*C*", +"temperature_max_12","temperature_max_12","WorldClim_2.1_CMCC-ESM2_ssp370_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Dec","max T Dec","december","degrees Celsius","*degree*C*", +"bio01","bio01","WorldClim_2.1_CMCC-ESM2_ssp585_10m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual mean temperature","ann. mean T","year","degrees Celsius","*degree*C*", +"bio02","bio02","WorldClim_2.1_CMCC-ESM2_ssp585_10m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean diurnal range","diurn. range","year","degrees Celsius","*degree*C*", +"bio03","bio03","WorldClim_2.1_CMCC-ESM2_ssp585_10m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","isothermality","isothermality","year","","", +"bio04","bio04","WorldClim_2.1_CMCC-ESM2_ssp585_10m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature seasonality","T season.","year","degrees Celsius","*degree*C*", +"bio05","bio05","WorldClim_2.1_CMCC-ESM2_ssp585_10m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature of warmest month","max. T of warmest mo.","year","degrees Celsius","*degree*C*", +"bio06","bio06","WorldClim_2.1_CMCC-ESM2_ssp585_10m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature of coldest month","min. T of coldest mo.","year","degrees Celsius","*degree*C*", +"bio07","bio07","WorldClim_2.1_CMCC-ESM2_ssp585_10m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature annual range (bio05-bio06)","T ann. Range","year","degrees Celsius","*degree*C*", +"bio08","bio08","WorldClim_2.1_CMCC-ESM2_ssp585_10m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of wettest quarter","mean T of wettest qtr","year","degrees Celsius","*degree*C*", +"bio09","bio09","WorldClim_2.1_CMCC-ESM2_ssp585_10m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of driest quarter","mean T of driest qtr","year","degrees Celsius","*degree*C*", +"bio10","bio10","WorldClim_2.1_CMCC-ESM2_ssp585_10m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of warmest quarter","mean T of warmest qtr","year","degrees Celsius","*degree*C*", +"bio11","bio11","WorldClim_2.1_CMCC-ESM2_ssp585_10m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of coldest quarter","mean T of coldest qtr","year","degrees Celsius","*degree*C*", +"bio12","bio12","WorldClim_2.1_CMCC-ESM2_ssp585_10m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual precipitation","ann. P","year","mm per year","*mm~yr^-1*", +"bio13","bio13","WorldClim_2.1_CMCC-ESM2_ssp585_10m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest month","P of wettest mo.","year","mm per month","*mm~mo^-1*", +"bio14","bio14","WorldClim_2.1_CMCC-ESM2_ssp585_10m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest month","P of driest mo.","year","mm per month","*mm~mo^-1*", +"bio15","bio15","WorldClim_2.1_CMCC-ESM2_ssp585_10m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation seasonality (coeff var)","P season.","year","","", +"bio16","bio16","WorldClim_2.1_CMCC-ESM2_ssp585_10m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest quarter","P of wettest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio17","bio17","WorldClim_2.1_CMCC-ESM2_ssp585_10m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest quarter","P of driest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio18","bio18","WorldClim_2.1_CMCC-ESM2_ssp585_10m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of warmest quarter","P of warmest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio19","bio19","WorldClim_2.1_CMCC-ESM2_ssp585_10m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of coldest quarter","P of coldest qtr","year","mm per quarter","*mm~qtr^-1*", +"precipitation_01","precipitation_01","WorldClim_2.1_CMCC-ESM2_ssp585_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jan","P Jan","january","mm per month","*mm~mo^-1*", +"precipitation_02","precipitation_02","WorldClim_2.1_CMCC-ESM2_ssp585_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Feb","P Feb","february","mm per month","*mm~mo^-1*", +"precipitation_03","precipitation_03","WorldClim_2.1_CMCC-ESM2_ssp585_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Mar","P Mar","march","mm per month","*mm~mo^-1*", +"precipitation_04","precipitation_04","WorldClim_2.1_CMCC-ESM2_ssp585_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Apr","P Apr","april","mm per month","*mm~mo^-1*", +"precipitation_05","precipitation_05","WorldClim_2.1_CMCC-ESM2_ssp585_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation May","P May","may","mm per month","*mm~mo^-1*", +"precipitation_06","precipitation_06","WorldClim_2.1_CMCC-ESM2_ssp585_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jun","P Jun","june","mm per month","*mm~mo^-1*", +"precipitation_07","precipitation_07","WorldClim_2.1_CMCC-ESM2_ssp585_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jul","P Jul","july","mm per month","*mm~mo^-1*", +"precipitation_08","precipitation_08","WorldClim_2.1_CMCC-ESM2_ssp585_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Aug","P Aug","august","mm per month","*mm~mo^-1*", +"precipitation_09","precipitation_09","WorldClim_2.1_CMCC-ESM2_ssp585_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Sep","P Sep","september","mm per month","*mm~mo^-1*", +"precipitation_10","precipitation_10","WorldClim_2.1_CMCC-ESM2_ssp585_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Oct","P Oct","october","mm per month","*mm~mo^-1*", +"precipitation_11","precipitation_11","WorldClim_2.1_CMCC-ESM2_ssp585_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Nov","P Nov","november","mm per month","*mm~mo^-1*", +"precipitation_12","precipitation_12","WorldClim_2.1_CMCC-ESM2_ssp585_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Dec","P Dec","december","mm per month","*mm~mo^-1*", +"temperature_min_01","temperature_min_01","WorldClim_2.1_CMCC-ESM2_ssp585_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jan","min T Jan","january","degrees Celsius","*degree*C*", +"temperature_min_02","temperature_min_02","WorldClim_2.1_CMCC-ESM2_ssp585_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Feb","min T Feb","february","degrees Celsius","*degree*C*", +"temperature_min_03","temperature_min_03","WorldClim_2.1_CMCC-ESM2_ssp585_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Mar","min T Mar","march","degrees Celsius","*degree*C*", +"temperature_min_04","temperature_min_04","WorldClim_2.1_CMCC-ESM2_ssp585_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Apr","min T Apr","april","degrees Celsius","*degree*C*", +"temperature_min_05","temperature_min_05","WorldClim_2.1_CMCC-ESM2_ssp585_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature May","min T May","may","degrees Celsius","*degree*C*", +"temperature_min_06","temperature_min_06","WorldClim_2.1_CMCC-ESM2_ssp585_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jun","min T Jun","june","degrees Celsius","*degree*C*", +"temperature_min_07","temperature_min_07","WorldClim_2.1_CMCC-ESM2_ssp585_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jul","min T Jul","july","degrees Celsius","*degree*C*", +"temperature_min_08","temperature_min_08","WorldClim_2.1_CMCC-ESM2_ssp585_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Aug","min T Aug","august","degrees Celsius","*degree*C*", +"temperature_min_09","temperature_min_09","WorldClim_2.1_CMCC-ESM2_ssp585_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Sep","min T Sep","september","degrees Celsius","*degree*C*", +"temperature_min_10","temperature_min_10","WorldClim_2.1_CMCC-ESM2_ssp585_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Oct","min T Oct","october","degrees Celsius","*degree*C*", +"temperature_min_11","temperature_min_11","WorldClim_2.1_CMCC-ESM2_ssp585_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Nov","min T Nov","november","degrees Celsius","*degree*C*", +"temperature_min_12","temperature_min_12","WorldClim_2.1_CMCC-ESM2_ssp585_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Dec","min T Dec","december","degrees Celsius","*degree*C*", +"temperature_max_01","temperature_max_01","WorldClim_2.1_CMCC-ESM2_ssp585_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jan","max T Jan","january","degrees Celsius","*degree*C*", +"temperature_max_02","temperature_max_02","WorldClim_2.1_CMCC-ESM2_ssp585_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Feb","max T Feb","february","degrees Celsius","*degree*C*", +"temperature_max_03","temperature_max_03","WorldClim_2.1_CMCC-ESM2_ssp585_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Mar","max T Mar","march","degrees Celsius","*degree*C*", +"temperature_max_04","temperature_max_04","WorldClim_2.1_CMCC-ESM2_ssp585_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Apr","max T Apr","april","degrees Celsius","*degree*C*", +"temperature_max_05","temperature_max_05","WorldClim_2.1_CMCC-ESM2_ssp585_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature May","max T May","may","degrees Celsius","*degree*C*", +"temperature_max_06","temperature_max_06","WorldClim_2.1_CMCC-ESM2_ssp585_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jun","max T Jun","june","degrees Celsius","*degree*C*", +"temperature_max_07","temperature_max_07","WorldClim_2.1_CMCC-ESM2_ssp585_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jul","max T Jul","july","degrees Celsius","*degree*C*", +"temperature_max_08","temperature_max_08","WorldClim_2.1_CMCC-ESM2_ssp585_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Aug","max T Aug","august","degrees Celsius","*degree*C*", +"temperature_max_09","temperature_max_09","WorldClim_2.1_CMCC-ESM2_ssp585_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Sep","max T Sep","september","degrees Celsius","*degree*C*", +"temperature_max_10","temperature_max_10","WorldClim_2.1_CMCC-ESM2_ssp585_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Oct","max T Oct","october","degrees Celsius","*degree*C*", +"temperature_max_11","temperature_max_11","WorldClim_2.1_CMCC-ESM2_ssp585_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Nov","max T Nov","november","degrees Celsius","*degree*C*", +"temperature_max_12","temperature_max_12","WorldClim_2.1_CMCC-ESM2_ssp585_10m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Dec","max T Dec","december","degrees Celsius","*degree*C*", +"bio01","bio01","WorldClim_2.1_CMCC-ESM2_ssp585_5m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual mean temperature","ann. mean T","year","degrees Celsius","*degree*C*", +"bio02","bio02","WorldClim_2.1_CMCC-ESM2_ssp585_5m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean diurnal range","diurn. range","year","degrees Celsius","*degree*C*", +"bio03","bio03","WorldClim_2.1_CMCC-ESM2_ssp585_5m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","isothermality","isothermality","year","","", +"bio04","bio04","WorldClim_2.1_CMCC-ESM2_ssp585_5m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature seasonality","T season.","year","degrees Celsius","*degree*C*", +"bio05","bio05","WorldClim_2.1_CMCC-ESM2_ssp585_5m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature of warmest month","max. T of warmest mo.","year","degrees Celsius","*degree*C*", +"bio06","bio06","WorldClim_2.1_CMCC-ESM2_ssp585_5m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature of coldest month","min. T of coldest mo.","year","degrees Celsius","*degree*C*", +"bio07","bio07","WorldClim_2.1_CMCC-ESM2_ssp585_5m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature annual range (bio05-bio06)","T ann. Range","year","degrees Celsius","*degree*C*", +"bio08","bio08","WorldClim_2.1_CMCC-ESM2_ssp585_5m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of wettest quarter","mean T of wettest qtr","year","degrees Celsius","*degree*C*", +"bio09","bio09","WorldClim_2.1_CMCC-ESM2_ssp585_5m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of driest quarter","mean T of driest qtr","year","degrees Celsius","*degree*C*", +"bio10","bio10","WorldClim_2.1_CMCC-ESM2_ssp585_5m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of warmest quarter","mean T of warmest qtr","year","degrees Celsius","*degree*C*", +"bio11","bio11","WorldClim_2.1_CMCC-ESM2_ssp585_5m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of coldest quarter","mean T of coldest qtr","year","degrees Celsius","*degree*C*", +"bio12","bio12","WorldClim_2.1_CMCC-ESM2_ssp585_5m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual precipitation","ann. P","year","mm per year","*mm~yr^-1*", +"bio13","bio13","WorldClim_2.1_CMCC-ESM2_ssp585_5m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest month","P of wettest mo.","year","mm per month","*mm~mo^-1*", +"bio14","bio14","WorldClim_2.1_CMCC-ESM2_ssp585_5m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest month","P of driest mo.","year","mm per month","*mm~mo^-1*", +"bio15","bio15","WorldClim_2.1_CMCC-ESM2_ssp585_5m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation seasonality (coeff var)","P season.","year","","", +"bio16","bio16","WorldClim_2.1_CMCC-ESM2_ssp585_5m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest quarter","P of wettest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio17","bio17","WorldClim_2.1_CMCC-ESM2_ssp585_5m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest quarter","P of driest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio18","bio18","WorldClim_2.1_CMCC-ESM2_ssp585_5m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of warmest quarter","P of warmest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio19","bio19","WorldClim_2.1_CMCC-ESM2_ssp585_5m",FALSE,"WorldClim_2.1_CMCC-ESM2_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of coldest quarter","P of coldest qtr","year","mm per quarter","*mm~qtr^-1*", +"precipitation_01","precipitation_01","WorldClim_2.1_CMCC-ESM2_ssp585_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jan","P Jan","january","mm per month","*mm~mo^-1*", +"precipitation_02","precipitation_02","WorldClim_2.1_CMCC-ESM2_ssp585_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Feb","P Feb","february","mm per month","*mm~mo^-1*", +"precipitation_03","precipitation_03","WorldClim_2.1_CMCC-ESM2_ssp585_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Mar","P Mar","march","mm per month","*mm~mo^-1*", +"precipitation_04","precipitation_04","WorldClim_2.1_CMCC-ESM2_ssp585_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Apr","P Apr","april","mm per month","*mm~mo^-1*", +"precipitation_05","precipitation_05","WorldClim_2.1_CMCC-ESM2_ssp585_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation May","P May","may","mm per month","*mm~mo^-1*", +"precipitation_06","precipitation_06","WorldClim_2.1_CMCC-ESM2_ssp585_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jun","P Jun","june","mm per month","*mm~mo^-1*", +"precipitation_07","precipitation_07","WorldClim_2.1_CMCC-ESM2_ssp585_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jul","P Jul","july","mm per month","*mm~mo^-1*", +"precipitation_08","precipitation_08","WorldClim_2.1_CMCC-ESM2_ssp585_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Aug","P Aug","august","mm per month","*mm~mo^-1*", +"precipitation_09","precipitation_09","WorldClim_2.1_CMCC-ESM2_ssp585_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Sep","P Sep","september","mm per month","*mm~mo^-1*", +"precipitation_10","precipitation_10","WorldClim_2.1_CMCC-ESM2_ssp585_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Oct","P Oct","october","mm per month","*mm~mo^-1*", +"precipitation_11","precipitation_11","WorldClim_2.1_CMCC-ESM2_ssp585_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Nov","P Nov","november","mm per month","*mm~mo^-1*", +"precipitation_12","precipitation_12","WorldClim_2.1_CMCC-ESM2_ssp585_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Dec","P Dec","december","mm per month","*mm~mo^-1*", +"temperature_min_01","temperature_min_01","WorldClim_2.1_CMCC-ESM2_ssp585_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jan","min T Jan","january","degrees Celsius","*degree*C*", +"temperature_min_02","temperature_min_02","WorldClim_2.1_CMCC-ESM2_ssp585_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Feb","min T Feb","february","degrees Celsius","*degree*C*", +"temperature_min_03","temperature_min_03","WorldClim_2.1_CMCC-ESM2_ssp585_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Mar","min T Mar","march","degrees Celsius","*degree*C*", +"temperature_min_04","temperature_min_04","WorldClim_2.1_CMCC-ESM2_ssp585_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Apr","min T Apr","april","degrees Celsius","*degree*C*", +"temperature_min_05","temperature_min_05","WorldClim_2.1_CMCC-ESM2_ssp585_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature May","min T May","may","degrees Celsius","*degree*C*", +"temperature_min_06","temperature_min_06","WorldClim_2.1_CMCC-ESM2_ssp585_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jun","min T Jun","june","degrees Celsius","*degree*C*", +"temperature_min_07","temperature_min_07","WorldClim_2.1_CMCC-ESM2_ssp585_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jul","min T Jul","july","degrees Celsius","*degree*C*", +"temperature_min_08","temperature_min_08","WorldClim_2.1_CMCC-ESM2_ssp585_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Aug","min T Aug","august","degrees Celsius","*degree*C*", +"temperature_min_09","temperature_min_09","WorldClim_2.1_CMCC-ESM2_ssp585_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Sep","min T Sep","september","degrees Celsius","*degree*C*", +"temperature_min_10","temperature_min_10","WorldClim_2.1_CMCC-ESM2_ssp585_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Oct","min T Oct","october","degrees Celsius","*degree*C*", +"temperature_min_11","temperature_min_11","WorldClim_2.1_CMCC-ESM2_ssp585_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Nov","min T Nov","november","degrees Celsius","*degree*C*", +"temperature_min_12","temperature_min_12","WorldClim_2.1_CMCC-ESM2_ssp585_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Dec","min T Dec","december","degrees Celsius","*degree*C*", +"temperature_max_01","temperature_max_01","WorldClim_2.1_CMCC-ESM2_ssp585_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jan","max T Jan","january","degrees Celsius","*degree*C*", +"temperature_max_02","temperature_max_02","WorldClim_2.1_CMCC-ESM2_ssp585_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Feb","max T Feb","february","degrees Celsius","*degree*C*", +"temperature_max_03","temperature_max_03","WorldClim_2.1_CMCC-ESM2_ssp585_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Mar","max T Mar","march","degrees Celsius","*degree*C*", +"temperature_max_04","temperature_max_04","WorldClim_2.1_CMCC-ESM2_ssp585_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Apr","max T Apr","april","degrees Celsius","*degree*C*", +"temperature_max_05","temperature_max_05","WorldClim_2.1_CMCC-ESM2_ssp585_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature May","max T May","may","degrees Celsius","*degree*C*", +"temperature_max_06","temperature_max_06","WorldClim_2.1_CMCC-ESM2_ssp585_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jun","max T Jun","june","degrees Celsius","*degree*C*", +"temperature_max_07","temperature_max_07","WorldClim_2.1_CMCC-ESM2_ssp585_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jul","max T Jul","july","degrees Celsius","*degree*C*", +"temperature_max_08","temperature_max_08","WorldClim_2.1_CMCC-ESM2_ssp585_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Aug","max T Aug","august","degrees Celsius","*degree*C*", +"temperature_max_09","temperature_max_09","WorldClim_2.1_CMCC-ESM2_ssp585_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Sep","max T Sep","september","degrees Celsius","*degree*C*", +"temperature_max_10","temperature_max_10","WorldClim_2.1_CMCC-ESM2_ssp585_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Oct","max T Oct","october","degrees Celsius","*degree*C*", +"temperature_max_11","temperature_max_11","WorldClim_2.1_CMCC-ESM2_ssp585_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Nov","max T Nov","november","degrees Celsius","*degree*C*", +"temperature_max_12","temperature_max_12","WorldClim_2.1_CMCC-ESM2_ssp585_5m",TRUE,"WorldClim_2.1_CMCC-ESM2_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Dec","max T Dec","december","degrees Celsius","*degree*C*", +"bio01","bio01","WorldClim_2.1_EC-Earth3-Veg_ssp126_10m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual mean temperature","ann. mean T","year","degrees Celsius","*degree*C*", +"bio02","bio02","WorldClim_2.1_EC-Earth3-Veg_ssp126_10m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean diurnal range","diurn. range","year","degrees Celsius","*degree*C*", +"bio03","bio03","WorldClim_2.1_EC-Earth3-Veg_ssp126_10m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","isothermality","isothermality","year","","", +"bio04","bio04","WorldClim_2.1_EC-Earth3-Veg_ssp126_10m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature seasonality","T season.","year","degrees Celsius","*degree*C*", +"bio05","bio05","WorldClim_2.1_EC-Earth3-Veg_ssp126_10m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature of warmest month","max. T of warmest mo.","year","degrees Celsius","*degree*C*", +"bio06","bio06","WorldClim_2.1_EC-Earth3-Veg_ssp126_10m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature of coldest month","min. T of coldest mo.","year","degrees Celsius","*degree*C*", +"bio07","bio07","WorldClim_2.1_EC-Earth3-Veg_ssp126_10m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature annual range (bio05-bio06)","T ann. Range","year","degrees Celsius","*degree*C*", +"bio08","bio08","WorldClim_2.1_EC-Earth3-Veg_ssp126_10m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of wettest quarter","mean T of wettest qtr","year","degrees Celsius","*degree*C*", +"bio09","bio09","WorldClim_2.1_EC-Earth3-Veg_ssp126_10m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of driest quarter","mean T of driest qtr","year","degrees Celsius","*degree*C*", +"bio10","bio10","WorldClim_2.1_EC-Earth3-Veg_ssp126_10m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of warmest quarter","mean T of warmest qtr","year","degrees Celsius","*degree*C*", +"bio11","bio11","WorldClim_2.1_EC-Earth3-Veg_ssp126_10m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of coldest quarter","mean T of coldest qtr","year","degrees Celsius","*degree*C*", +"bio12","bio12","WorldClim_2.1_EC-Earth3-Veg_ssp126_10m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual precipitation","ann. P","year","mm per year","*mm~yr^-1*", +"bio13","bio13","WorldClim_2.1_EC-Earth3-Veg_ssp126_10m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest month","P of wettest mo.","year","mm per month","*mm~mo^-1*", +"bio14","bio14","WorldClim_2.1_EC-Earth3-Veg_ssp126_10m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest month","P of driest mo.","year","mm per month","*mm~mo^-1*", +"bio15","bio15","WorldClim_2.1_EC-Earth3-Veg_ssp126_10m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation seasonality (coeff var)","P season.","year","","", +"bio16","bio16","WorldClim_2.1_EC-Earth3-Veg_ssp126_10m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest quarter","P of wettest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio17","bio17","WorldClim_2.1_EC-Earth3-Veg_ssp126_10m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest quarter","P of driest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio18","bio18","WorldClim_2.1_EC-Earth3-Veg_ssp126_10m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of warmest quarter","P of warmest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio19","bio19","WorldClim_2.1_EC-Earth3-Veg_ssp126_10m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of coldest quarter","P of coldest qtr","year","mm per quarter","*mm~qtr^-1*", +"precipitation_01","precipitation_01","WorldClim_2.1_EC-Earth3-Veg_ssp126_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jan","P Jan","january","mm per month","*mm~mo^-1*", +"precipitation_02","precipitation_02","WorldClim_2.1_EC-Earth3-Veg_ssp126_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Feb","P Feb","february","mm per month","*mm~mo^-1*", +"precipitation_03","precipitation_03","WorldClim_2.1_EC-Earth3-Veg_ssp126_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Mar","P Mar","march","mm per month","*mm~mo^-1*", +"precipitation_04","precipitation_04","WorldClim_2.1_EC-Earth3-Veg_ssp126_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Apr","P Apr","april","mm per month","*mm~mo^-1*", +"precipitation_05","precipitation_05","WorldClim_2.1_EC-Earth3-Veg_ssp126_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation May","P May","may","mm per month","*mm~mo^-1*", +"precipitation_06","precipitation_06","WorldClim_2.1_EC-Earth3-Veg_ssp126_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jun","P Jun","june","mm per month","*mm~mo^-1*", +"precipitation_07","precipitation_07","WorldClim_2.1_EC-Earth3-Veg_ssp126_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jul","P Jul","july","mm per month","*mm~mo^-1*", +"precipitation_08","precipitation_08","WorldClim_2.1_EC-Earth3-Veg_ssp126_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Aug","P Aug","august","mm per month","*mm~mo^-1*", +"precipitation_09","precipitation_09","WorldClim_2.1_EC-Earth3-Veg_ssp126_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Sep","P Sep","september","mm per month","*mm~mo^-1*", +"precipitation_10","precipitation_10","WorldClim_2.1_EC-Earth3-Veg_ssp126_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Oct","P Oct","october","mm per month","*mm~mo^-1*", +"precipitation_11","precipitation_11","WorldClim_2.1_EC-Earth3-Veg_ssp126_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Nov","P Nov","november","mm per month","*mm~mo^-1*", +"precipitation_12","precipitation_12","WorldClim_2.1_EC-Earth3-Veg_ssp126_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Dec","P Dec","december","mm per month","*mm~mo^-1*", +"temperature_min_01","temperature_min_01","WorldClim_2.1_EC-Earth3-Veg_ssp126_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jan","min T Jan","january","degrees Celsius","*degree*C*", +"temperature_min_02","temperature_min_02","WorldClim_2.1_EC-Earth3-Veg_ssp126_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Feb","min T Feb","february","degrees Celsius","*degree*C*", +"temperature_min_03","temperature_min_03","WorldClim_2.1_EC-Earth3-Veg_ssp126_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Mar","min T Mar","march","degrees Celsius","*degree*C*", +"temperature_min_04","temperature_min_04","WorldClim_2.1_EC-Earth3-Veg_ssp126_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Apr","min T Apr","april","degrees Celsius","*degree*C*", +"temperature_min_05","temperature_min_05","WorldClim_2.1_EC-Earth3-Veg_ssp126_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature May","min T May","may","degrees Celsius","*degree*C*", +"temperature_min_06","temperature_min_06","WorldClim_2.1_EC-Earth3-Veg_ssp126_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jun","min T Jun","june","degrees Celsius","*degree*C*", +"temperature_min_07","temperature_min_07","WorldClim_2.1_EC-Earth3-Veg_ssp126_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jul","min T Jul","july","degrees Celsius","*degree*C*", +"temperature_min_08","temperature_min_08","WorldClim_2.1_EC-Earth3-Veg_ssp126_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Aug","min T Aug","august","degrees Celsius","*degree*C*", +"temperature_min_09","temperature_min_09","WorldClim_2.1_EC-Earth3-Veg_ssp126_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Sep","min T Sep","september","degrees Celsius","*degree*C*", +"temperature_min_10","temperature_min_10","WorldClim_2.1_EC-Earth3-Veg_ssp126_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Oct","min T Oct","october","degrees Celsius","*degree*C*", +"temperature_min_11","temperature_min_11","WorldClim_2.1_EC-Earth3-Veg_ssp126_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Nov","min T Nov","november","degrees Celsius","*degree*C*", +"temperature_min_12","temperature_min_12","WorldClim_2.1_EC-Earth3-Veg_ssp126_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Dec","min T Dec","december","degrees Celsius","*degree*C*", +"temperature_max_01","temperature_max_01","WorldClim_2.1_EC-Earth3-Veg_ssp126_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jan","max T Jan","january","degrees Celsius","*degree*C*", +"temperature_max_02","temperature_max_02","WorldClim_2.1_EC-Earth3-Veg_ssp126_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Feb","max T Feb","february","degrees Celsius","*degree*C*", +"temperature_max_03","temperature_max_03","WorldClim_2.1_EC-Earth3-Veg_ssp126_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Mar","max T Mar","march","degrees Celsius","*degree*C*", +"temperature_max_04","temperature_max_04","WorldClim_2.1_EC-Earth3-Veg_ssp126_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Apr","max T Apr","april","degrees Celsius","*degree*C*", +"temperature_max_05","temperature_max_05","WorldClim_2.1_EC-Earth3-Veg_ssp126_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature May","max T May","may","degrees Celsius","*degree*C*", +"temperature_max_06","temperature_max_06","WorldClim_2.1_EC-Earth3-Veg_ssp126_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jun","max T Jun","june","degrees Celsius","*degree*C*", +"temperature_max_07","temperature_max_07","WorldClim_2.1_EC-Earth3-Veg_ssp126_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jul","max T Jul","july","degrees Celsius","*degree*C*", +"temperature_max_08","temperature_max_08","WorldClim_2.1_EC-Earth3-Veg_ssp126_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Aug","max T Aug","august","degrees Celsius","*degree*C*", +"temperature_max_09","temperature_max_09","WorldClim_2.1_EC-Earth3-Veg_ssp126_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Sep","max T Sep","september","degrees Celsius","*degree*C*", +"temperature_max_10","temperature_max_10","WorldClim_2.1_EC-Earth3-Veg_ssp126_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Oct","max T Oct","october","degrees Celsius","*degree*C*", +"temperature_max_11","temperature_max_11","WorldClim_2.1_EC-Earth3-Veg_ssp126_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Nov","max T Nov","november","degrees Celsius","*degree*C*", +"temperature_max_12","temperature_max_12","WorldClim_2.1_EC-Earth3-Veg_ssp126_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Dec","max T Dec","december","degrees Celsius","*degree*C*", +"bio01","bio01","WorldClim_2.1_EC-Earth3-Veg_ssp126_5m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual mean temperature","ann. mean T","year","degrees Celsius","*degree*C*", +"bio02","bio02","WorldClim_2.1_EC-Earth3-Veg_ssp126_5m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean diurnal range","diurn. range","year","degrees Celsius","*degree*C*", +"bio03","bio03","WorldClim_2.1_EC-Earth3-Veg_ssp126_5m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","isothermality","isothermality","year","","", +"bio04","bio04","WorldClim_2.1_EC-Earth3-Veg_ssp126_5m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature seasonality","T season.","year","degrees Celsius","*degree*C*", +"bio05","bio05","WorldClim_2.1_EC-Earth3-Veg_ssp126_5m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature of warmest month","max. T of warmest mo.","year","degrees Celsius","*degree*C*", +"bio06","bio06","WorldClim_2.1_EC-Earth3-Veg_ssp126_5m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature of coldest month","min. T of coldest mo.","year","degrees Celsius","*degree*C*", +"bio07","bio07","WorldClim_2.1_EC-Earth3-Veg_ssp126_5m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature annual range (bio05-bio06)","T ann. Range","year","degrees Celsius","*degree*C*", +"bio08","bio08","WorldClim_2.1_EC-Earth3-Veg_ssp126_5m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of wettest quarter","mean T of wettest qtr","year","degrees Celsius","*degree*C*", +"bio09","bio09","WorldClim_2.1_EC-Earth3-Veg_ssp126_5m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of driest quarter","mean T of driest qtr","year","degrees Celsius","*degree*C*", +"bio10","bio10","WorldClim_2.1_EC-Earth3-Veg_ssp126_5m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of warmest quarter","mean T of warmest qtr","year","degrees Celsius","*degree*C*", +"bio11","bio11","WorldClim_2.1_EC-Earth3-Veg_ssp126_5m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of coldest quarter","mean T of coldest qtr","year","degrees Celsius","*degree*C*", +"bio12","bio12","WorldClim_2.1_EC-Earth3-Veg_ssp126_5m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual precipitation","ann. P","year","mm per year","*mm~yr^-1*", +"bio13","bio13","WorldClim_2.1_EC-Earth3-Veg_ssp126_5m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest month","P of wettest mo.","year","mm per month","*mm~mo^-1*", +"bio14","bio14","WorldClim_2.1_EC-Earth3-Veg_ssp126_5m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest month","P of driest mo.","year","mm per month","*mm~mo^-1*", +"bio15","bio15","WorldClim_2.1_EC-Earth3-Veg_ssp126_5m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation seasonality (coeff var)","P season.","year","","", +"bio16","bio16","WorldClim_2.1_EC-Earth3-Veg_ssp126_5m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest quarter","P of wettest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio17","bio17","WorldClim_2.1_EC-Earth3-Veg_ssp126_5m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest quarter","P of driest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio18","bio18","WorldClim_2.1_EC-Earth3-Veg_ssp126_5m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of warmest quarter","P of warmest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio19","bio19","WorldClim_2.1_EC-Earth3-Veg_ssp126_5m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of coldest quarter","P of coldest qtr","year","mm per quarter","*mm~qtr^-1*", +"precipitation_01","precipitation_01","WorldClim_2.1_EC-Earth3-Veg_ssp126_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jan","P Jan","january","mm per month","*mm~mo^-1*", +"precipitation_02","precipitation_02","WorldClim_2.1_EC-Earth3-Veg_ssp126_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Feb","P Feb","february","mm per month","*mm~mo^-1*", +"precipitation_03","precipitation_03","WorldClim_2.1_EC-Earth3-Veg_ssp126_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Mar","P Mar","march","mm per month","*mm~mo^-1*", +"precipitation_04","precipitation_04","WorldClim_2.1_EC-Earth3-Veg_ssp126_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Apr","P Apr","april","mm per month","*mm~mo^-1*", +"precipitation_05","precipitation_05","WorldClim_2.1_EC-Earth3-Veg_ssp126_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation May","P May","may","mm per month","*mm~mo^-1*", +"precipitation_06","precipitation_06","WorldClim_2.1_EC-Earth3-Veg_ssp126_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jun","P Jun","june","mm per month","*mm~mo^-1*", +"precipitation_07","precipitation_07","WorldClim_2.1_EC-Earth3-Veg_ssp126_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jul","P Jul","july","mm per month","*mm~mo^-1*", +"precipitation_08","precipitation_08","WorldClim_2.1_EC-Earth3-Veg_ssp126_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Aug","P Aug","august","mm per month","*mm~mo^-1*", +"precipitation_09","precipitation_09","WorldClim_2.1_EC-Earth3-Veg_ssp126_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Sep","P Sep","september","mm per month","*mm~mo^-1*", +"precipitation_10","precipitation_10","WorldClim_2.1_EC-Earth3-Veg_ssp126_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Oct","P Oct","october","mm per month","*mm~mo^-1*", +"precipitation_11","precipitation_11","WorldClim_2.1_EC-Earth3-Veg_ssp126_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Nov","P Nov","november","mm per month","*mm~mo^-1*", +"precipitation_12","precipitation_12","WorldClim_2.1_EC-Earth3-Veg_ssp126_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Dec","P Dec","december","mm per month","*mm~mo^-1*", +"temperature_min_01","temperature_min_01","WorldClim_2.1_EC-Earth3-Veg_ssp126_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jan","min T Jan","january","degrees Celsius","*degree*C*", +"temperature_min_02","temperature_min_02","WorldClim_2.1_EC-Earth3-Veg_ssp126_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Feb","min T Feb","february","degrees Celsius","*degree*C*", +"temperature_min_03","temperature_min_03","WorldClim_2.1_EC-Earth3-Veg_ssp126_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Mar","min T Mar","march","degrees Celsius","*degree*C*", +"temperature_min_04","temperature_min_04","WorldClim_2.1_EC-Earth3-Veg_ssp126_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Apr","min T Apr","april","degrees Celsius","*degree*C*", +"temperature_min_05","temperature_min_05","WorldClim_2.1_EC-Earth3-Veg_ssp126_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature May","min T May","may","degrees Celsius","*degree*C*", +"temperature_min_06","temperature_min_06","WorldClim_2.1_EC-Earth3-Veg_ssp126_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jun","min T Jun","june","degrees Celsius","*degree*C*", +"temperature_min_07","temperature_min_07","WorldClim_2.1_EC-Earth3-Veg_ssp126_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jul","min T Jul","july","degrees Celsius","*degree*C*", +"temperature_min_08","temperature_min_08","WorldClim_2.1_EC-Earth3-Veg_ssp126_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Aug","min T Aug","august","degrees Celsius","*degree*C*", +"temperature_min_09","temperature_min_09","WorldClim_2.1_EC-Earth3-Veg_ssp126_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Sep","min T Sep","september","degrees Celsius","*degree*C*", +"temperature_min_10","temperature_min_10","WorldClim_2.1_EC-Earth3-Veg_ssp126_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Oct","min T Oct","october","degrees Celsius","*degree*C*", +"temperature_min_11","temperature_min_11","WorldClim_2.1_EC-Earth3-Veg_ssp126_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Nov","min T Nov","november","degrees Celsius","*degree*C*", +"temperature_min_12","temperature_min_12","WorldClim_2.1_EC-Earth3-Veg_ssp126_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Dec","min T Dec","december","degrees Celsius","*degree*C*", +"temperature_max_01","temperature_max_01","WorldClim_2.1_EC-Earth3-Veg_ssp126_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jan","max T Jan","january","degrees Celsius","*degree*C*", +"temperature_max_02","temperature_max_02","WorldClim_2.1_EC-Earth3-Veg_ssp126_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Feb","max T Feb","february","degrees Celsius","*degree*C*", +"temperature_max_03","temperature_max_03","WorldClim_2.1_EC-Earth3-Veg_ssp126_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Mar","max T Mar","march","degrees Celsius","*degree*C*", +"temperature_max_04","temperature_max_04","WorldClim_2.1_EC-Earth3-Veg_ssp126_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Apr","max T Apr","april","degrees Celsius","*degree*C*", +"temperature_max_05","temperature_max_05","WorldClim_2.1_EC-Earth3-Veg_ssp126_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature May","max T May","may","degrees Celsius","*degree*C*", +"temperature_max_06","temperature_max_06","WorldClim_2.1_EC-Earth3-Veg_ssp126_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jun","max T Jun","june","degrees Celsius","*degree*C*", +"temperature_max_07","temperature_max_07","WorldClim_2.1_EC-Earth3-Veg_ssp126_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jul","max T Jul","july","degrees Celsius","*degree*C*", +"temperature_max_08","temperature_max_08","WorldClim_2.1_EC-Earth3-Veg_ssp126_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Aug","max T Aug","august","degrees Celsius","*degree*C*", +"temperature_max_09","temperature_max_09","WorldClim_2.1_EC-Earth3-Veg_ssp126_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Sep","max T Sep","september","degrees Celsius","*degree*C*", +"temperature_max_10","temperature_max_10","WorldClim_2.1_EC-Earth3-Veg_ssp126_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Oct","max T Oct","october","degrees Celsius","*degree*C*", +"temperature_max_11","temperature_max_11","WorldClim_2.1_EC-Earth3-Veg_ssp126_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Nov","max T Nov","november","degrees Celsius","*degree*C*", +"temperature_max_12","temperature_max_12","WorldClim_2.1_EC-Earth3-Veg_ssp126_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Dec","max T Dec","december","degrees Celsius","*degree*C*", +"bio01","bio01","WorldClim_2.1_EC-Earth3-Veg_ssp245_10m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual mean temperature","ann. mean T","year","degrees Celsius","*degree*C*", +"bio02","bio02","WorldClim_2.1_EC-Earth3-Veg_ssp245_10m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean diurnal range","diurn. range","year","degrees Celsius","*degree*C*", +"bio03","bio03","WorldClim_2.1_EC-Earth3-Veg_ssp245_10m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","isothermality","isothermality","year","","", +"bio04","bio04","WorldClim_2.1_EC-Earth3-Veg_ssp245_10m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature seasonality","T season.","year","degrees Celsius","*degree*C*", +"bio05","bio05","WorldClim_2.1_EC-Earth3-Veg_ssp245_10m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature of warmest month","max. T of warmest mo.","year","degrees Celsius","*degree*C*", +"bio06","bio06","WorldClim_2.1_EC-Earth3-Veg_ssp245_10m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature of coldest month","min. T of coldest mo.","year","degrees Celsius","*degree*C*", +"bio07","bio07","WorldClim_2.1_EC-Earth3-Veg_ssp245_10m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature annual range (bio05-bio06)","T ann. Range","year","degrees Celsius","*degree*C*", +"bio08","bio08","WorldClim_2.1_EC-Earth3-Veg_ssp245_10m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of wettest quarter","mean T of wettest qtr","year","degrees Celsius","*degree*C*", +"bio09","bio09","WorldClim_2.1_EC-Earth3-Veg_ssp245_10m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of driest quarter","mean T of driest qtr","year","degrees Celsius","*degree*C*", +"bio10","bio10","WorldClim_2.1_EC-Earth3-Veg_ssp245_10m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of warmest quarter","mean T of warmest qtr","year","degrees Celsius","*degree*C*", +"bio11","bio11","WorldClim_2.1_EC-Earth3-Veg_ssp245_10m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of coldest quarter","mean T of coldest qtr","year","degrees Celsius","*degree*C*", +"bio12","bio12","WorldClim_2.1_EC-Earth3-Veg_ssp245_10m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual precipitation","ann. P","year","mm per year","*mm~yr^-1*", +"bio13","bio13","WorldClim_2.1_EC-Earth3-Veg_ssp245_10m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest month","P of wettest mo.","year","mm per month","*mm~mo^-1*", +"bio14","bio14","WorldClim_2.1_EC-Earth3-Veg_ssp245_10m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest month","P of driest mo.","year","mm per month","*mm~mo^-1*", +"bio15","bio15","WorldClim_2.1_EC-Earth3-Veg_ssp245_10m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation seasonality (coeff var)","P season.","year","","", +"bio16","bio16","WorldClim_2.1_EC-Earth3-Veg_ssp245_10m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest quarter","P of wettest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio17","bio17","WorldClim_2.1_EC-Earth3-Veg_ssp245_10m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest quarter","P of driest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio18","bio18","WorldClim_2.1_EC-Earth3-Veg_ssp245_10m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of warmest quarter","P of warmest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio19","bio19","WorldClim_2.1_EC-Earth3-Veg_ssp245_10m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of coldest quarter","P of coldest qtr","year","mm per quarter","*mm~qtr^-1*", +"precipitation_01","precipitation_01","WorldClim_2.1_EC-Earth3-Veg_ssp245_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jan","P Jan","january","mm per month","*mm~mo^-1*", +"precipitation_02","precipitation_02","WorldClim_2.1_EC-Earth3-Veg_ssp245_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Feb","P Feb","february","mm per month","*mm~mo^-1*", +"precipitation_03","precipitation_03","WorldClim_2.1_EC-Earth3-Veg_ssp245_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Mar","P Mar","march","mm per month","*mm~mo^-1*", +"precipitation_04","precipitation_04","WorldClim_2.1_EC-Earth3-Veg_ssp245_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Apr","P Apr","april","mm per month","*mm~mo^-1*", +"precipitation_05","precipitation_05","WorldClim_2.1_EC-Earth3-Veg_ssp245_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation May","P May","may","mm per month","*mm~mo^-1*", +"precipitation_06","precipitation_06","WorldClim_2.1_EC-Earth3-Veg_ssp245_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jun","P Jun","june","mm per month","*mm~mo^-1*", +"precipitation_07","precipitation_07","WorldClim_2.1_EC-Earth3-Veg_ssp245_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jul","P Jul","july","mm per month","*mm~mo^-1*", +"precipitation_08","precipitation_08","WorldClim_2.1_EC-Earth3-Veg_ssp245_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Aug","P Aug","august","mm per month","*mm~mo^-1*", +"precipitation_09","precipitation_09","WorldClim_2.1_EC-Earth3-Veg_ssp245_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Sep","P Sep","september","mm per month","*mm~mo^-1*", +"precipitation_10","precipitation_10","WorldClim_2.1_EC-Earth3-Veg_ssp245_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Oct","P Oct","october","mm per month","*mm~mo^-1*", +"precipitation_11","precipitation_11","WorldClim_2.1_EC-Earth3-Veg_ssp245_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Nov","P Nov","november","mm per month","*mm~mo^-1*", +"precipitation_12","precipitation_12","WorldClim_2.1_EC-Earth3-Veg_ssp245_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Dec","P Dec","december","mm per month","*mm~mo^-1*", +"temperature_min_01","temperature_min_01","WorldClim_2.1_EC-Earth3-Veg_ssp245_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jan","min T Jan","january","degrees Celsius","*degree*C*", +"temperature_min_02","temperature_min_02","WorldClim_2.1_EC-Earth3-Veg_ssp245_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Feb","min T Feb","february","degrees Celsius","*degree*C*", +"temperature_min_03","temperature_min_03","WorldClim_2.1_EC-Earth3-Veg_ssp245_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Mar","min T Mar","march","degrees Celsius","*degree*C*", +"temperature_min_04","temperature_min_04","WorldClim_2.1_EC-Earth3-Veg_ssp245_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Apr","min T Apr","april","degrees Celsius","*degree*C*", +"temperature_min_05","temperature_min_05","WorldClim_2.1_EC-Earth3-Veg_ssp245_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature May","min T May","may","degrees Celsius","*degree*C*", +"temperature_min_06","temperature_min_06","WorldClim_2.1_EC-Earth3-Veg_ssp245_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jun","min T Jun","june","degrees Celsius","*degree*C*", +"temperature_min_07","temperature_min_07","WorldClim_2.1_EC-Earth3-Veg_ssp245_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jul","min T Jul","july","degrees Celsius","*degree*C*", +"temperature_min_08","temperature_min_08","WorldClim_2.1_EC-Earth3-Veg_ssp245_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Aug","min T Aug","august","degrees Celsius","*degree*C*", +"temperature_min_09","temperature_min_09","WorldClim_2.1_EC-Earth3-Veg_ssp245_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Sep","min T Sep","september","degrees Celsius","*degree*C*", +"temperature_min_10","temperature_min_10","WorldClim_2.1_EC-Earth3-Veg_ssp245_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Oct","min T Oct","october","degrees Celsius","*degree*C*", +"temperature_min_11","temperature_min_11","WorldClim_2.1_EC-Earth3-Veg_ssp245_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Nov","min T Nov","november","degrees Celsius","*degree*C*", +"temperature_min_12","temperature_min_12","WorldClim_2.1_EC-Earth3-Veg_ssp245_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Dec","min T Dec","december","degrees Celsius","*degree*C*", +"temperature_max_01","temperature_max_01","WorldClim_2.1_EC-Earth3-Veg_ssp245_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jan","max T Jan","january","degrees Celsius","*degree*C*", +"temperature_max_02","temperature_max_02","WorldClim_2.1_EC-Earth3-Veg_ssp245_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Feb","max T Feb","february","degrees Celsius","*degree*C*", +"temperature_max_03","temperature_max_03","WorldClim_2.1_EC-Earth3-Veg_ssp245_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Mar","max T Mar","march","degrees Celsius","*degree*C*", +"temperature_max_04","temperature_max_04","WorldClim_2.1_EC-Earth3-Veg_ssp245_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Apr","max T Apr","april","degrees Celsius","*degree*C*", +"temperature_max_05","temperature_max_05","WorldClim_2.1_EC-Earth3-Veg_ssp245_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature May","max T May","may","degrees Celsius","*degree*C*", +"temperature_max_06","temperature_max_06","WorldClim_2.1_EC-Earth3-Veg_ssp245_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jun","max T Jun","june","degrees Celsius","*degree*C*", +"temperature_max_07","temperature_max_07","WorldClim_2.1_EC-Earth3-Veg_ssp245_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jul","max T Jul","july","degrees Celsius","*degree*C*", +"temperature_max_08","temperature_max_08","WorldClim_2.1_EC-Earth3-Veg_ssp245_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Aug","max T Aug","august","degrees Celsius","*degree*C*", +"temperature_max_09","temperature_max_09","WorldClim_2.1_EC-Earth3-Veg_ssp245_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Sep","max T Sep","september","degrees Celsius","*degree*C*", +"temperature_max_10","temperature_max_10","WorldClim_2.1_EC-Earth3-Veg_ssp245_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Oct","max T Oct","october","degrees Celsius","*degree*C*", +"temperature_max_11","temperature_max_11","WorldClim_2.1_EC-Earth3-Veg_ssp245_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Nov","max T Nov","november","degrees Celsius","*degree*C*", +"temperature_max_12","temperature_max_12","WorldClim_2.1_EC-Earth3-Veg_ssp245_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Dec","max T Dec","december","degrees Celsius","*degree*C*", +"bio01","bio01","WorldClim_2.1_EC-Earth3-Veg_ssp245_5m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual mean temperature","ann. mean T","year","degrees Celsius","*degree*C*", +"bio02","bio02","WorldClim_2.1_EC-Earth3-Veg_ssp245_5m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean diurnal range","diurn. range","year","degrees Celsius","*degree*C*", +"bio03","bio03","WorldClim_2.1_EC-Earth3-Veg_ssp245_5m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","isothermality","isothermality","year","","", +"bio04","bio04","WorldClim_2.1_EC-Earth3-Veg_ssp245_5m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature seasonality","T season.","year","degrees Celsius","*degree*C*", +"bio05","bio05","WorldClim_2.1_EC-Earth3-Veg_ssp245_5m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature of warmest month","max. T of warmest mo.","year","degrees Celsius","*degree*C*", +"bio06","bio06","WorldClim_2.1_EC-Earth3-Veg_ssp245_5m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature of coldest month","min. T of coldest mo.","year","degrees Celsius","*degree*C*", +"bio07","bio07","WorldClim_2.1_EC-Earth3-Veg_ssp245_5m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature annual range (bio05-bio06)","T ann. Range","year","degrees Celsius","*degree*C*", +"bio08","bio08","WorldClim_2.1_EC-Earth3-Veg_ssp245_5m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of wettest quarter","mean T of wettest qtr","year","degrees Celsius","*degree*C*", +"bio09","bio09","WorldClim_2.1_EC-Earth3-Veg_ssp245_5m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of driest quarter","mean T of driest qtr","year","degrees Celsius","*degree*C*", +"bio10","bio10","WorldClim_2.1_EC-Earth3-Veg_ssp245_5m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of warmest quarter","mean T of warmest qtr","year","degrees Celsius","*degree*C*", +"bio11","bio11","WorldClim_2.1_EC-Earth3-Veg_ssp245_5m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of coldest quarter","mean T of coldest qtr","year","degrees Celsius","*degree*C*", +"bio12","bio12","WorldClim_2.1_EC-Earth3-Veg_ssp245_5m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual precipitation","ann. P","year","mm per year","*mm~yr^-1*", +"bio13","bio13","WorldClim_2.1_EC-Earth3-Veg_ssp245_5m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest month","P of wettest mo.","year","mm per month","*mm~mo^-1*", +"bio14","bio14","WorldClim_2.1_EC-Earth3-Veg_ssp245_5m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest month","P of driest mo.","year","mm per month","*mm~mo^-1*", +"bio15","bio15","WorldClim_2.1_EC-Earth3-Veg_ssp245_5m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation seasonality (coeff var)","P season.","year","","", +"bio16","bio16","WorldClim_2.1_EC-Earth3-Veg_ssp245_5m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest quarter","P of wettest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio17","bio17","WorldClim_2.1_EC-Earth3-Veg_ssp245_5m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest quarter","P of driest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio18","bio18","WorldClim_2.1_EC-Earth3-Veg_ssp245_5m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of warmest quarter","P of warmest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio19","bio19","WorldClim_2.1_EC-Earth3-Veg_ssp245_5m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of coldest quarter","P of coldest qtr","year","mm per quarter","*mm~qtr^-1*", +"precipitation_01","precipitation_01","WorldClim_2.1_EC-Earth3-Veg_ssp245_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jan","P Jan","january","mm per month","*mm~mo^-1*", +"precipitation_02","precipitation_02","WorldClim_2.1_EC-Earth3-Veg_ssp245_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Feb","P Feb","february","mm per month","*mm~mo^-1*", +"precipitation_03","precipitation_03","WorldClim_2.1_EC-Earth3-Veg_ssp245_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Mar","P Mar","march","mm per month","*mm~mo^-1*", +"precipitation_04","precipitation_04","WorldClim_2.1_EC-Earth3-Veg_ssp245_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Apr","P Apr","april","mm per month","*mm~mo^-1*", +"precipitation_05","precipitation_05","WorldClim_2.1_EC-Earth3-Veg_ssp245_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation May","P May","may","mm per month","*mm~mo^-1*", +"precipitation_06","precipitation_06","WorldClim_2.1_EC-Earth3-Veg_ssp245_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jun","P Jun","june","mm per month","*mm~mo^-1*", +"precipitation_07","precipitation_07","WorldClim_2.1_EC-Earth3-Veg_ssp245_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jul","P Jul","july","mm per month","*mm~mo^-1*", +"precipitation_08","precipitation_08","WorldClim_2.1_EC-Earth3-Veg_ssp245_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Aug","P Aug","august","mm per month","*mm~mo^-1*", +"precipitation_09","precipitation_09","WorldClim_2.1_EC-Earth3-Veg_ssp245_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Sep","P Sep","september","mm per month","*mm~mo^-1*", +"precipitation_10","precipitation_10","WorldClim_2.1_EC-Earth3-Veg_ssp245_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Oct","P Oct","october","mm per month","*mm~mo^-1*", +"precipitation_11","precipitation_11","WorldClim_2.1_EC-Earth3-Veg_ssp245_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Nov","P Nov","november","mm per month","*mm~mo^-1*", +"precipitation_12","precipitation_12","WorldClim_2.1_EC-Earth3-Veg_ssp245_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Dec","P Dec","december","mm per month","*mm~mo^-1*", +"temperature_min_01","temperature_min_01","WorldClim_2.1_EC-Earth3-Veg_ssp245_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jan","min T Jan","january","degrees Celsius","*degree*C*", +"temperature_min_02","temperature_min_02","WorldClim_2.1_EC-Earth3-Veg_ssp245_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Feb","min T Feb","february","degrees Celsius","*degree*C*", +"temperature_min_03","temperature_min_03","WorldClim_2.1_EC-Earth3-Veg_ssp245_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Mar","min T Mar","march","degrees Celsius","*degree*C*", +"temperature_min_04","temperature_min_04","WorldClim_2.1_EC-Earth3-Veg_ssp245_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Apr","min T Apr","april","degrees Celsius","*degree*C*", +"temperature_min_05","temperature_min_05","WorldClim_2.1_EC-Earth3-Veg_ssp245_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature May","min T May","may","degrees Celsius","*degree*C*", +"temperature_min_06","temperature_min_06","WorldClim_2.1_EC-Earth3-Veg_ssp245_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jun","min T Jun","june","degrees Celsius","*degree*C*", +"temperature_min_07","temperature_min_07","WorldClim_2.1_EC-Earth3-Veg_ssp245_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jul","min T Jul","july","degrees Celsius","*degree*C*", +"temperature_min_08","temperature_min_08","WorldClim_2.1_EC-Earth3-Veg_ssp245_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Aug","min T Aug","august","degrees Celsius","*degree*C*", +"temperature_min_09","temperature_min_09","WorldClim_2.1_EC-Earth3-Veg_ssp245_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Sep","min T Sep","september","degrees Celsius","*degree*C*", +"temperature_min_10","temperature_min_10","WorldClim_2.1_EC-Earth3-Veg_ssp245_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Oct","min T Oct","october","degrees Celsius","*degree*C*", +"temperature_min_11","temperature_min_11","WorldClim_2.1_EC-Earth3-Veg_ssp245_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Nov","min T Nov","november","degrees Celsius","*degree*C*", +"temperature_min_12","temperature_min_12","WorldClim_2.1_EC-Earth3-Veg_ssp245_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Dec","min T Dec","december","degrees Celsius","*degree*C*", +"temperature_max_01","temperature_max_01","WorldClim_2.1_EC-Earth3-Veg_ssp245_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jan","max T Jan","january","degrees Celsius","*degree*C*", +"temperature_max_02","temperature_max_02","WorldClim_2.1_EC-Earth3-Veg_ssp245_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Feb","max T Feb","february","degrees Celsius","*degree*C*", +"temperature_max_03","temperature_max_03","WorldClim_2.1_EC-Earth3-Veg_ssp245_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Mar","max T Mar","march","degrees Celsius","*degree*C*", +"temperature_max_04","temperature_max_04","WorldClim_2.1_EC-Earth3-Veg_ssp245_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Apr","max T Apr","april","degrees Celsius","*degree*C*", +"temperature_max_05","temperature_max_05","WorldClim_2.1_EC-Earth3-Veg_ssp245_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature May","max T May","may","degrees Celsius","*degree*C*", +"temperature_max_06","temperature_max_06","WorldClim_2.1_EC-Earth3-Veg_ssp245_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jun","max T Jun","june","degrees Celsius","*degree*C*", +"temperature_max_07","temperature_max_07","WorldClim_2.1_EC-Earth3-Veg_ssp245_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jul","max T Jul","july","degrees Celsius","*degree*C*", +"temperature_max_08","temperature_max_08","WorldClim_2.1_EC-Earth3-Veg_ssp245_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Aug","max T Aug","august","degrees Celsius","*degree*C*", +"temperature_max_09","temperature_max_09","WorldClim_2.1_EC-Earth3-Veg_ssp245_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Sep","max T Sep","september","degrees Celsius","*degree*C*", +"temperature_max_10","temperature_max_10","WorldClim_2.1_EC-Earth3-Veg_ssp245_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Oct","max T Oct","october","degrees Celsius","*degree*C*", +"temperature_max_11","temperature_max_11","WorldClim_2.1_EC-Earth3-Veg_ssp245_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Nov","max T Nov","november","degrees Celsius","*degree*C*", +"temperature_max_12","temperature_max_12","WorldClim_2.1_EC-Earth3-Veg_ssp245_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Dec","max T Dec","december","degrees Celsius","*degree*C*", +"bio01","bio01","WorldClim_2.1_EC-Earth3-Veg_ssp370_10m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual mean temperature","ann. mean T","year","degrees Celsius","*degree*C*", +"bio02","bio02","WorldClim_2.1_EC-Earth3-Veg_ssp370_10m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean diurnal range","diurn. range","year","degrees Celsius","*degree*C*", +"bio03","bio03","WorldClim_2.1_EC-Earth3-Veg_ssp370_10m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","isothermality","isothermality","year","","", +"bio04","bio04","WorldClim_2.1_EC-Earth3-Veg_ssp370_10m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature seasonality","T season.","year","degrees Celsius","*degree*C*", +"bio05","bio05","WorldClim_2.1_EC-Earth3-Veg_ssp370_10m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature of warmest month","max. T of warmest mo.","year","degrees Celsius","*degree*C*", +"bio06","bio06","WorldClim_2.1_EC-Earth3-Veg_ssp370_10m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature of coldest month","min. T of coldest mo.","year","degrees Celsius","*degree*C*", +"bio07","bio07","WorldClim_2.1_EC-Earth3-Veg_ssp370_10m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature annual range (bio05-bio06)","T ann. Range","year","degrees Celsius","*degree*C*", +"bio08","bio08","WorldClim_2.1_EC-Earth3-Veg_ssp370_10m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of wettest quarter","mean T of wettest qtr","year","degrees Celsius","*degree*C*", +"bio09","bio09","WorldClim_2.1_EC-Earth3-Veg_ssp370_10m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of driest quarter","mean T of driest qtr","year","degrees Celsius","*degree*C*", +"bio10","bio10","WorldClim_2.1_EC-Earth3-Veg_ssp370_10m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of warmest quarter","mean T of warmest qtr","year","degrees Celsius","*degree*C*", +"bio11","bio11","WorldClim_2.1_EC-Earth3-Veg_ssp370_10m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of coldest quarter","mean T of coldest qtr","year","degrees Celsius","*degree*C*", +"bio12","bio12","WorldClim_2.1_EC-Earth3-Veg_ssp370_10m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual precipitation","ann. P","year","mm per year","*mm~yr^-1*", +"bio13","bio13","WorldClim_2.1_EC-Earth3-Veg_ssp370_10m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest month","P of wettest mo.","year","mm per month","*mm~mo^-1*", +"bio14","bio14","WorldClim_2.1_EC-Earth3-Veg_ssp370_10m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest month","P of driest mo.","year","mm per month","*mm~mo^-1*", +"bio15","bio15","WorldClim_2.1_EC-Earth3-Veg_ssp370_10m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation seasonality (coeff var)","P season.","year","","", +"bio16","bio16","WorldClim_2.1_EC-Earth3-Veg_ssp370_10m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest quarter","P of wettest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio17","bio17","WorldClim_2.1_EC-Earth3-Veg_ssp370_10m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest quarter","P of driest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio18","bio18","WorldClim_2.1_EC-Earth3-Veg_ssp370_10m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of warmest quarter","P of warmest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio19","bio19","WorldClim_2.1_EC-Earth3-Veg_ssp370_10m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of coldest quarter","P of coldest qtr","year","mm per quarter","*mm~qtr^-1*", +"precipitation_01","precipitation_01","WorldClim_2.1_EC-Earth3-Veg_ssp370_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jan","P Jan","january","mm per month","*mm~mo^-1*", +"precipitation_02","precipitation_02","WorldClim_2.1_EC-Earth3-Veg_ssp370_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Feb","P Feb","february","mm per month","*mm~mo^-1*", +"precipitation_03","precipitation_03","WorldClim_2.1_EC-Earth3-Veg_ssp370_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Mar","P Mar","march","mm per month","*mm~mo^-1*", +"precipitation_04","precipitation_04","WorldClim_2.1_EC-Earth3-Veg_ssp370_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Apr","P Apr","april","mm per month","*mm~mo^-1*", +"precipitation_05","precipitation_05","WorldClim_2.1_EC-Earth3-Veg_ssp370_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation May","P May","may","mm per month","*mm~mo^-1*", +"precipitation_06","precipitation_06","WorldClim_2.1_EC-Earth3-Veg_ssp370_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jun","P Jun","june","mm per month","*mm~mo^-1*", +"precipitation_07","precipitation_07","WorldClim_2.1_EC-Earth3-Veg_ssp370_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jul","P Jul","july","mm per month","*mm~mo^-1*", +"precipitation_08","precipitation_08","WorldClim_2.1_EC-Earth3-Veg_ssp370_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Aug","P Aug","august","mm per month","*mm~mo^-1*", +"precipitation_09","precipitation_09","WorldClim_2.1_EC-Earth3-Veg_ssp370_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Sep","P Sep","september","mm per month","*mm~mo^-1*", +"precipitation_10","precipitation_10","WorldClim_2.1_EC-Earth3-Veg_ssp370_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Oct","P Oct","october","mm per month","*mm~mo^-1*", +"precipitation_11","precipitation_11","WorldClim_2.1_EC-Earth3-Veg_ssp370_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Nov","P Nov","november","mm per month","*mm~mo^-1*", +"precipitation_12","precipitation_12","WorldClim_2.1_EC-Earth3-Veg_ssp370_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Dec","P Dec","december","mm per month","*mm~mo^-1*", +"temperature_min_01","temperature_min_01","WorldClim_2.1_EC-Earth3-Veg_ssp370_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jan","min T Jan","january","degrees Celsius","*degree*C*", +"temperature_min_02","temperature_min_02","WorldClim_2.1_EC-Earth3-Veg_ssp370_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Feb","min T Feb","february","degrees Celsius","*degree*C*", +"temperature_min_03","temperature_min_03","WorldClim_2.1_EC-Earth3-Veg_ssp370_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Mar","min T Mar","march","degrees Celsius","*degree*C*", +"temperature_min_04","temperature_min_04","WorldClim_2.1_EC-Earth3-Veg_ssp370_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Apr","min T Apr","april","degrees Celsius","*degree*C*", +"temperature_min_05","temperature_min_05","WorldClim_2.1_EC-Earth3-Veg_ssp370_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature May","min T May","may","degrees Celsius","*degree*C*", +"temperature_min_06","temperature_min_06","WorldClim_2.1_EC-Earth3-Veg_ssp370_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jun","min T Jun","june","degrees Celsius","*degree*C*", +"temperature_min_07","temperature_min_07","WorldClim_2.1_EC-Earth3-Veg_ssp370_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jul","min T Jul","july","degrees Celsius","*degree*C*", +"temperature_min_08","temperature_min_08","WorldClim_2.1_EC-Earth3-Veg_ssp370_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Aug","min T Aug","august","degrees Celsius","*degree*C*", +"temperature_min_09","temperature_min_09","WorldClim_2.1_EC-Earth3-Veg_ssp370_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Sep","min T Sep","september","degrees Celsius","*degree*C*", +"temperature_min_10","temperature_min_10","WorldClim_2.1_EC-Earth3-Veg_ssp370_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Oct","min T Oct","october","degrees Celsius","*degree*C*", +"temperature_min_11","temperature_min_11","WorldClim_2.1_EC-Earth3-Veg_ssp370_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Nov","min T Nov","november","degrees Celsius","*degree*C*", +"temperature_min_12","temperature_min_12","WorldClim_2.1_EC-Earth3-Veg_ssp370_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Dec","min T Dec","december","degrees Celsius","*degree*C*", +"temperature_max_01","temperature_max_01","WorldClim_2.1_EC-Earth3-Veg_ssp370_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jan","max T Jan","january","degrees Celsius","*degree*C*", +"temperature_max_02","temperature_max_02","WorldClim_2.1_EC-Earth3-Veg_ssp370_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Feb","max T Feb","february","degrees Celsius","*degree*C*", +"temperature_max_03","temperature_max_03","WorldClim_2.1_EC-Earth3-Veg_ssp370_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Mar","max T Mar","march","degrees Celsius","*degree*C*", +"temperature_max_04","temperature_max_04","WorldClim_2.1_EC-Earth3-Veg_ssp370_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Apr","max T Apr","april","degrees Celsius","*degree*C*", +"temperature_max_05","temperature_max_05","WorldClim_2.1_EC-Earth3-Veg_ssp370_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature May","max T May","may","degrees Celsius","*degree*C*", +"temperature_max_06","temperature_max_06","WorldClim_2.1_EC-Earth3-Veg_ssp370_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jun","max T Jun","june","degrees Celsius","*degree*C*", +"temperature_max_07","temperature_max_07","WorldClim_2.1_EC-Earth3-Veg_ssp370_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jul","max T Jul","july","degrees Celsius","*degree*C*", +"temperature_max_08","temperature_max_08","WorldClim_2.1_EC-Earth3-Veg_ssp370_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Aug","max T Aug","august","degrees Celsius","*degree*C*", +"temperature_max_09","temperature_max_09","WorldClim_2.1_EC-Earth3-Veg_ssp370_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Sep","max T Sep","september","degrees Celsius","*degree*C*", +"temperature_max_10","temperature_max_10","WorldClim_2.1_EC-Earth3-Veg_ssp370_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Oct","max T Oct","october","degrees Celsius","*degree*C*", +"temperature_max_11","temperature_max_11","WorldClim_2.1_EC-Earth3-Veg_ssp370_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Nov","max T Nov","november","degrees Celsius","*degree*C*", +"temperature_max_12","temperature_max_12","WorldClim_2.1_EC-Earth3-Veg_ssp370_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Dec","max T Dec","december","degrees Celsius","*degree*C*", +"bio01","bio01","WorldClim_2.1_EC-Earth3-Veg_ssp370_5m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual mean temperature","ann. mean T","year","degrees Celsius","*degree*C*", +"bio02","bio02","WorldClim_2.1_EC-Earth3-Veg_ssp370_5m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean diurnal range","diurn. range","year","degrees Celsius","*degree*C*", +"bio03","bio03","WorldClim_2.1_EC-Earth3-Veg_ssp370_5m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","isothermality","isothermality","year","","", +"bio04","bio04","WorldClim_2.1_EC-Earth3-Veg_ssp370_5m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature seasonality","T season.","year","degrees Celsius","*degree*C*", +"bio05","bio05","WorldClim_2.1_EC-Earth3-Veg_ssp370_5m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature of warmest month","max. T of warmest mo.","year","degrees Celsius","*degree*C*", +"bio06","bio06","WorldClim_2.1_EC-Earth3-Veg_ssp370_5m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature of coldest month","min. T of coldest mo.","year","degrees Celsius","*degree*C*", +"bio07","bio07","WorldClim_2.1_EC-Earth3-Veg_ssp370_5m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature annual range (bio05-bio06)","T ann. Range","year","degrees Celsius","*degree*C*", +"bio08","bio08","WorldClim_2.1_EC-Earth3-Veg_ssp370_5m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of wettest quarter","mean T of wettest qtr","year","degrees Celsius","*degree*C*", +"bio09","bio09","WorldClim_2.1_EC-Earth3-Veg_ssp370_5m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of driest quarter","mean T of driest qtr","year","degrees Celsius","*degree*C*", +"bio10","bio10","WorldClim_2.1_EC-Earth3-Veg_ssp370_5m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of warmest quarter","mean T of warmest qtr","year","degrees Celsius","*degree*C*", +"bio11","bio11","WorldClim_2.1_EC-Earth3-Veg_ssp370_5m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of coldest quarter","mean T of coldest qtr","year","degrees Celsius","*degree*C*", +"bio12","bio12","WorldClim_2.1_EC-Earth3-Veg_ssp370_5m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual precipitation","ann. P","year","mm per year","*mm~yr^-1*", +"bio13","bio13","WorldClim_2.1_EC-Earth3-Veg_ssp370_5m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest month","P of wettest mo.","year","mm per month","*mm~mo^-1*", +"bio14","bio14","WorldClim_2.1_EC-Earth3-Veg_ssp370_5m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest month","P of driest mo.","year","mm per month","*mm~mo^-1*", +"bio15","bio15","WorldClim_2.1_EC-Earth3-Veg_ssp370_5m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation seasonality (coeff var)","P season.","year","","", +"bio16","bio16","WorldClim_2.1_EC-Earth3-Veg_ssp370_5m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest quarter","P of wettest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio17","bio17","WorldClim_2.1_EC-Earth3-Veg_ssp370_5m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest quarter","P of driest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio18","bio18","WorldClim_2.1_EC-Earth3-Veg_ssp370_5m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of warmest quarter","P of warmest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio19","bio19","WorldClim_2.1_EC-Earth3-Veg_ssp370_5m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of coldest quarter","P of coldest qtr","year","mm per quarter","*mm~qtr^-1*", +"precipitation_01","precipitation_01","WorldClim_2.1_EC-Earth3-Veg_ssp370_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jan","P Jan","january","mm per month","*mm~mo^-1*", +"precipitation_02","precipitation_02","WorldClim_2.1_EC-Earth3-Veg_ssp370_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Feb","P Feb","february","mm per month","*mm~mo^-1*", +"precipitation_03","precipitation_03","WorldClim_2.1_EC-Earth3-Veg_ssp370_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Mar","P Mar","march","mm per month","*mm~mo^-1*", +"precipitation_04","precipitation_04","WorldClim_2.1_EC-Earth3-Veg_ssp370_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Apr","P Apr","april","mm per month","*mm~mo^-1*", +"precipitation_05","precipitation_05","WorldClim_2.1_EC-Earth3-Veg_ssp370_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation May","P May","may","mm per month","*mm~mo^-1*", +"precipitation_06","precipitation_06","WorldClim_2.1_EC-Earth3-Veg_ssp370_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jun","P Jun","june","mm per month","*mm~mo^-1*", +"precipitation_07","precipitation_07","WorldClim_2.1_EC-Earth3-Veg_ssp370_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jul","P Jul","july","mm per month","*mm~mo^-1*", +"precipitation_08","precipitation_08","WorldClim_2.1_EC-Earth3-Veg_ssp370_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Aug","P Aug","august","mm per month","*mm~mo^-1*", +"precipitation_09","precipitation_09","WorldClim_2.1_EC-Earth3-Veg_ssp370_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Sep","P Sep","september","mm per month","*mm~mo^-1*", +"precipitation_10","precipitation_10","WorldClim_2.1_EC-Earth3-Veg_ssp370_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Oct","P Oct","october","mm per month","*mm~mo^-1*", +"precipitation_11","precipitation_11","WorldClim_2.1_EC-Earth3-Veg_ssp370_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Nov","P Nov","november","mm per month","*mm~mo^-1*", +"precipitation_12","precipitation_12","WorldClim_2.1_EC-Earth3-Veg_ssp370_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Dec","P Dec","december","mm per month","*mm~mo^-1*", +"temperature_min_01","temperature_min_01","WorldClim_2.1_EC-Earth3-Veg_ssp370_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jan","min T Jan","january","degrees Celsius","*degree*C*", +"temperature_min_02","temperature_min_02","WorldClim_2.1_EC-Earth3-Veg_ssp370_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Feb","min T Feb","february","degrees Celsius","*degree*C*", +"temperature_min_03","temperature_min_03","WorldClim_2.1_EC-Earth3-Veg_ssp370_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Mar","min T Mar","march","degrees Celsius","*degree*C*", +"temperature_min_04","temperature_min_04","WorldClim_2.1_EC-Earth3-Veg_ssp370_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Apr","min T Apr","april","degrees Celsius","*degree*C*", +"temperature_min_05","temperature_min_05","WorldClim_2.1_EC-Earth3-Veg_ssp370_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature May","min T May","may","degrees Celsius","*degree*C*", +"temperature_min_06","temperature_min_06","WorldClim_2.1_EC-Earth3-Veg_ssp370_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jun","min T Jun","june","degrees Celsius","*degree*C*", +"temperature_min_07","temperature_min_07","WorldClim_2.1_EC-Earth3-Veg_ssp370_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jul","min T Jul","july","degrees Celsius","*degree*C*", +"temperature_min_08","temperature_min_08","WorldClim_2.1_EC-Earth3-Veg_ssp370_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Aug","min T Aug","august","degrees Celsius","*degree*C*", +"temperature_min_09","temperature_min_09","WorldClim_2.1_EC-Earth3-Veg_ssp370_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Sep","min T Sep","september","degrees Celsius","*degree*C*", +"temperature_min_10","temperature_min_10","WorldClim_2.1_EC-Earth3-Veg_ssp370_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Oct","min T Oct","october","degrees Celsius","*degree*C*", +"temperature_min_11","temperature_min_11","WorldClim_2.1_EC-Earth3-Veg_ssp370_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Nov","min T Nov","november","degrees Celsius","*degree*C*", +"temperature_min_12","temperature_min_12","WorldClim_2.1_EC-Earth3-Veg_ssp370_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Dec","min T Dec","december","degrees Celsius","*degree*C*", +"temperature_max_01","temperature_max_01","WorldClim_2.1_EC-Earth3-Veg_ssp370_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jan","max T Jan","january","degrees Celsius","*degree*C*", +"temperature_max_02","temperature_max_02","WorldClim_2.1_EC-Earth3-Veg_ssp370_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Feb","max T Feb","february","degrees Celsius","*degree*C*", +"temperature_max_03","temperature_max_03","WorldClim_2.1_EC-Earth3-Veg_ssp370_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Mar","max T Mar","march","degrees Celsius","*degree*C*", +"temperature_max_04","temperature_max_04","WorldClim_2.1_EC-Earth3-Veg_ssp370_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Apr","max T Apr","april","degrees Celsius","*degree*C*", +"temperature_max_05","temperature_max_05","WorldClim_2.1_EC-Earth3-Veg_ssp370_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature May","max T May","may","degrees Celsius","*degree*C*", +"temperature_max_06","temperature_max_06","WorldClim_2.1_EC-Earth3-Veg_ssp370_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jun","max T Jun","june","degrees Celsius","*degree*C*", +"temperature_max_07","temperature_max_07","WorldClim_2.1_EC-Earth3-Veg_ssp370_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jul","max T Jul","july","degrees Celsius","*degree*C*", +"temperature_max_08","temperature_max_08","WorldClim_2.1_EC-Earth3-Veg_ssp370_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Aug","max T Aug","august","degrees Celsius","*degree*C*", +"temperature_max_09","temperature_max_09","WorldClim_2.1_EC-Earth3-Veg_ssp370_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Sep","max T Sep","september","degrees Celsius","*degree*C*", +"temperature_max_10","temperature_max_10","WorldClim_2.1_EC-Earth3-Veg_ssp370_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Oct","max T Oct","october","degrees Celsius","*degree*C*", +"temperature_max_11","temperature_max_11","WorldClim_2.1_EC-Earth3-Veg_ssp370_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Nov","max T Nov","november","degrees Celsius","*degree*C*", +"temperature_max_12","temperature_max_12","WorldClim_2.1_EC-Earth3-Veg_ssp370_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Dec","max T Dec","december","degrees Celsius","*degree*C*", +"bio01","bio01","WorldClim_2.1_EC-Earth3-Veg_ssp585_10m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual mean temperature","ann. mean T","year","degrees Celsius","*degree*C*", +"bio02","bio02","WorldClim_2.1_EC-Earth3-Veg_ssp585_10m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean diurnal range","diurn. range","year","degrees Celsius","*degree*C*", +"bio03","bio03","WorldClim_2.1_EC-Earth3-Veg_ssp585_10m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","isothermality","isothermality","year","","", +"bio04","bio04","WorldClim_2.1_EC-Earth3-Veg_ssp585_10m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature seasonality","T season.","year","degrees Celsius","*degree*C*", +"bio05","bio05","WorldClim_2.1_EC-Earth3-Veg_ssp585_10m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature of warmest month","max. T of warmest mo.","year","degrees Celsius","*degree*C*", +"bio06","bio06","WorldClim_2.1_EC-Earth3-Veg_ssp585_10m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature of coldest month","min. T of coldest mo.","year","degrees Celsius","*degree*C*", +"bio07","bio07","WorldClim_2.1_EC-Earth3-Veg_ssp585_10m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature annual range (bio05-bio06)","T ann. Range","year","degrees Celsius","*degree*C*", +"bio08","bio08","WorldClim_2.1_EC-Earth3-Veg_ssp585_10m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of wettest quarter","mean T of wettest qtr","year","degrees Celsius","*degree*C*", +"bio09","bio09","WorldClim_2.1_EC-Earth3-Veg_ssp585_10m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of driest quarter","mean T of driest qtr","year","degrees Celsius","*degree*C*", +"bio10","bio10","WorldClim_2.1_EC-Earth3-Veg_ssp585_10m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of warmest quarter","mean T of warmest qtr","year","degrees Celsius","*degree*C*", +"bio11","bio11","WorldClim_2.1_EC-Earth3-Veg_ssp585_10m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of coldest quarter","mean T of coldest qtr","year","degrees Celsius","*degree*C*", +"bio12","bio12","WorldClim_2.1_EC-Earth3-Veg_ssp585_10m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual precipitation","ann. P","year","mm per year","*mm~yr^-1*", +"bio13","bio13","WorldClim_2.1_EC-Earth3-Veg_ssp585_10m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest month","P of wettest mo.","year","mm per month","*mm~mo^-1*", +"bio14","bio14","WorldClim_2.1_EC-Earth3-Veg_ssp585_10m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest month","P of driest mo.","year","mm per month","*mm~mo^-1*", +"bio15","bio15","WorldClim_2.1_EC-Earth3-Veg_ssp585_10m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation seasonality (coeff var)","P season.","year","","", +"bio16","bio16","WorldClim_2.1_EC-Earth3-Veg_ssp585_10m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest quarter","P of wettest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio17","bio17","WorldClim_2.1_EC-Earth3-Veg_ssp585_10m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest quarter","P of driest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio18","bio18","WorldClim_2.1_EC-Earth3-Veg_ssp585_10m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of warmest quarter","P of warmest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio19","bio19","WorldClim_2.1_EC-Earth3-Veg_ssp585_10m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of coldest quarter","P of coldest qtr","year","mm per quarter","*mm~qtr^-1*", +"precipitation_01","precipitation_01","WorldClim_2.1_EC-Earth3-Veg_ssp585_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jan","P Jan","january","mm per month","*mm~mo^-1*", +"precipitation_02","precipitation_02","WorldClim_2.1_EC-Earth3-Veg_ssp585_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Feb","P Feb","february","mm per month","*mm~mo^-1*", +"precipitation_03","precipitation_03","WorldClim_2.1_EC-Earth3-Veg_ssp585_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Mar","P Mar","march","mm per month","*mm~mo^-1*", +"precipitation_04","precipitation_04","WorldClim_2.1_EC-Earth3-Veg_ssp585_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Apr","P Apr","april","mm per month","*mm~mo^-1*", +"precipitation_05","precipitation_05","WorldClim_2.1_EC-Earth3-Veg_ssp585_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation May","P May","may","mm per month","*mm~mo^-1*", +"precipitation_06","precipitation_06","WorldClim_2.1_EC-Earth3-Veg_ssp585_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jun","P Jun","june","mm per month","*mm~mo^-1*", +"precipitation_07","precipitation_07","WorldClim_2.1_EC-Earth3-Veg_ssp585_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jul","P Jul","july","mm per month","*mm~mo^-1*", +"precipitation_08","precipitation_08","WorldClim_2.1_EC-Earth3-Veg_ssp585_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Aug","P Aug","august","mm per month","*mm~mo^-1*", +"precipitation_09","precipitation_09","WorldClim_2.1_EC-Earth3-Veg_ssp585_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Sep","P Sep","september","mm per month","*mm~mo^-1*", +"precipitation_10","precipitation_10","WorldClim_2.1_EC-Earth3-Veg_ssp585_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Oct","P Oct","october","mm per month","*mm~mo^-1*", +"precipitation_11","precipitation_11","WorldClim_2.1_EC-Earth3-Veg_ssp585_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Nov","P Nov","november","mm per month","*mm~mo^-1*", +"precipitation_12","precipitation_12","WorldClim_2.1_EC-Earth3-Veg_ssp585_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Dec","P Dec","december","mm per month","*mm~mo^-1*", +"temperature_min_01","temperature_min_01","WorldClim_2.1_EC-Earth3-Veg_ssp585_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jan","min T Jan","january","degrees Celsius","*degree*C*", +"temperature_min_02","temperature_min_02","WorldClim_2.1_EC-Earth3-Veg_ssp585_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Feb","min T Feb","february","degrees Celsius","*degree*C*", +"temperature_min_03","temperature_min_03","WorldClim_2.1_EC-Earth3-Veg_ssp585_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Mar","min T Mar","march","degrees Celsius","*degree*C*", +"temperature_min_04","temperature_min_04","WorldClim_2.1_EC-Earth3-Veg_ssp585_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Apr","min T Apr","april","degrees Celsius","*degree*C*", +"temperature_min_05","temperature_min_05","WorldClim_2.1_EC-Earth3-Veg_ssp585_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature May","min T May","may","degrees Celsius","*degree*C*", +"temperature_min_06","temperature_min_06","WorldClim_2.1_EC-Earth3-Veg_ssp585_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jun","min T Jun","june","degrees Celsius","*degree*C*", +"temperature_min_07","temperature_min_07","WorldClim_2.1_EC-Earth3-Veg_ssp585_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jul","min T Jul","july","degrees Celsius","*degree*C*", +"temperature_min_08","temperature_min_08","WorldClim_2.1_EC-Earth3-Veg_ssp585_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Aug","min T Aug","august","degrees Celsius","*degree*C*", +"temperature_min_09","temperature_min_09","WorldClim_2.1_EC-Earth3-Veg_ssp585_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Sep","min T Sep","september","degrees Celsius","*degree*C*", +"temperature_min_10","temperature_min_10","WorldClim_2.1_EC-Earth3-Veg_ssp585_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Oct","min T Oct","october","degrees Celsius","*degree*C*", +"temperature_min_11","temperature_min_11","WorldClim_2.1_EC-Earth3-Veg_ssp585_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Nov","min T Nov","november","degrees Celsius","*degree*C*", +"temperature_min_12","temperature_min_12","WorldClim_2.1_EC-Earth3-Veg_ssp585_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Dec","min T Dec","december","degrees Celsius","*degree*C*", +"temperature_max_01","temperature_max_01","WorldClim_2.1_EC-Earth3-Veg_ssp585_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jan","max T Jan","january","degrees Celsius","*degree*C*", +"temperature_max_02","temperature_max_02","WorldClim_2.1_EC-Earth3-Veg_ssp585_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Feb","max T Feb","february","degrees Celsius","*degree*C*", +"temperature_max_03","temperature_max_03","WorldClim_2.1_EC-Earth3-Veg_ssp585_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Mar","max T Mar","march","degrees Celsius","*degree*C*", +"temperature_max_04","temperature_max_04","WorldClim_2.1_EC-Earth3-Veg_ssp585_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Apr","max T Apr","april","degrees Celsius","*degree*C*", +"temperature_max_05","temperature_max_05","WorldClim_2.1_EC-Earth3-Veg_ssp585_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature May","max T May","may","degrees Celsius","*degree*C*", +"temperature_max_06","temperature_max_06","WorldClim_2.1_EC-Earth3-Veg_ssp585_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jun","max T Jun","june","degrees Celsius","*degree*C*", +"temperature_max_07","temperature_max_07","WorldClim_2.1_EC-Earth3-Veg_ssp585_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jul","max T Jul","july","degrees Celsius","*degree*C*", +"temperature_max_08","temperature_max_08","WorldClim_2.1_EC-Earth3-Veg_ssp585_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Aug","max T Aug","august","degrees Celsius","*degree*C*", +"temperature_max_09","temperature_max_09","WorldClim_2.1_EC-Earth3-Veg_ssp585_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Sep","max T Sep","september","degrees Celsius","*degree*C*", +"temperature_max_10","temperature_max_10","WorldClim_2.1_EC-Earth3-Veg_ssp585_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Oct","max T Oct","october","degrees Celsius","*degree*C*", +"temperature_max_11","temperature_max_11","WorldClim_2.1_EC-Earth3-Veg_ssp585_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Nov","max T Nov","november","degrees Celsius","*degree*C*", +"temperature_max_12","temperature_max_12","WorldClim_2.1_EC-Earth3-Veg_ssp585_10m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Dec","max T Dec","december","degrees Celsius","*degree*C*", +"bio01","bio01","WorldClim_2.1_EC-Earth3-Veg_ssp585_5m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual mean temperature","ann. mean T","year","degrees Celsius","*degree*C*", +"bio02","bio02","WorldClim_2.1_EC-Earth3-Veg_ssp585_5m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean diurnal range","diurn. range","year","degrees Celsius","*degree*C*", +"bio03","bio03","WorldClim_2.1_EC-Earth3-Veg_ssp585_5m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","isothermality","isothermality","year","","", +"bio04","bio04","WorldClim_2.1_EC-Earth3-Veg_ssp585_5m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature seasonality","T season.","year","degrees Celsius","*degree*C*", +"bio05","bio05","WorldClim_2.1_EC-Earth3-Veg_ssp585_5m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature of warmest month","max. T of warmest mo.","year","degrees Celsius","*degree*C*", +"bio06","bio06","WorldClim_2.1_EC-Earth3-Veg_ssp585_5m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature of coldest month","min. T of coldest mo.","year","degrees Celsius","*degree*C*", +"bio07","bio07","WorldClim_2.1_EC-Earth3-Veg_ssp585_5m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature annual range (bio05-bio06)","T ann. Range","year","degrees Celsius","*degree*C*", +"bio08","bio08","WorldClim_2.1_EC-Earth3-Veg_ssp585_5m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of wettest quarter","mean T of wettest qtr","year","degrees Celsius","*degree*C*", +"bio09","bio09","WorldClim_2.1_EC-Earth3-Veg_ssp585_5m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of driest quarter","mean T of driest qtr","year","degrees Celsius","*degree*C*", +"bio10","bio10","WorldClim_2.1_EC-Earth3-Veg_ssp585_5m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of warmest quarter","mean T of warmest qtr","year","degrees Celsius","*degree*C*", +"bio11","bio11","WorldClim_2.1_EC-Earth3-Veg_ssp585_5m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of coldest quarter","mean T of coldest qtr","year","degrees Celsius","*degree*C*", +"bio12","bio12","WorldClim_2.1_EC-Earth3-Veg_ssp585_5m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual precipitation","ann. P","year","mm per year","*mm~yr^-1*", +"bio13","bio13","WorldClim_2.1_EC-Earth3-Veg_ssp585_5m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest month","P of wettest mo.","year","mm per month","*mm~mo^-1*", +"bio14","bio14","WorldClim_2.1_EC-Earth3-Veg_ssp585_5m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest month","P of driest mo.","year","mm per month","*mm~mo^-1*", +"bio15","bio15","WorldClim_2.1_EC-Earth3-Veg_ssp585_5m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation seasonality (coeff var)","P season.","year","","", +"bio16","bio16","WorldClim_2.1_EC-Earth3-Veg_ssp585_5m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest quarter","P of wettest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio17","bio17","WorldClim_2.1_EC-Earth3-Veg_ssp585_5m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest quarter","P of driest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio18","bio18","WorldClim_2.1_EC-Earth3-Veg_ssp585_5m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of warmest quarter","P of warmest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio19","bio19","WorldClim_2.1_EC-Earth3-Veg_ssp585_5m",FALSE,"WorldClim_2.1_EC-Earth3-Veg_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of coldest quarter","P of coldest qtr","year","mm per quarter","*mm~qtr^-1*", +"precipitation_01","precipitation_01","WorldClim_2.1_EC-Earth3-Veg_ssp585_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jan","P Jan","january","mm per month","*mm~mo^-1*", +"precipitation_02","precipitation_02","WorldClim_2.1_EC-Earth3-Veg_ssp585_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Feb","P Feb","february","mm per month","*mm~mo^-1*", +"precipitation_03","precipitation_03","WorldClim_2.1_EC-Earth3-Veg_ssp585_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Mar","P Mar","march","mm per month","*mm~mo^-1*", +"precipitation_04","precipitation_04","WorldClim_2.1_EC-Earth3-Veg_ssp585_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Apr","P Apr","april","mm per month","*mm~mo^-1*", +"precipitation_05","precipitation_05","WorldClim_2.1_EC-Earth3-Veg_ssp585_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation May","P May","may","mm per month","*mm~mo^-1*", +"precipitation_06","precipitation_06","WorldClim_2.1_EC-Earth3-Veg_ssp585_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jun","P Jun","june","mm per month","*mm~mo^-1*", +"precipitation_07","precipitation_07","WorldClim_2.1_EC-Earth3-Veg_ssp585_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jul","P Jul","july","mm per month","*mm~mo^-1*", +"precipitation_08","precipitation_08","WorldClim_2.1_EC-Earth3-Veg_ssp585_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Aug","P Aug","august","mm per month","*mm~mo^-1*", +"precipitation_09","precipitation_09","WorldClim_2.1_EC-Earth3-Veg_ssp585_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Sep","P Sep","september","mm per month","*mm~mo^-1*", +"precipitation_10","precipitation_10","WorldClim_2.1_EC-Earth3-Veg_ssp585_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Oct","P Oct","october","mm per month","*mm~mo^-1*", +"precipitation_11","precipitation_11","WorldClim_2.1_EC-Earth3-Veg_ssp585_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Nov","P Nov","november","mm per month","*mm~mo^-1*", +"precipitation_12","precipitation_12","WorldClim_2.1_EC-Earth3-Veg_ssp585_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Dec","P Dec","december","mm per month","*mm~mo^-1*", +"temperature_min_01","temperature_min_01","WorldClim_2.1_EC-Earth3-Veg_ssp585_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jan","min T Jan","january","degrees Celsius","*degree*C*", +"temperature_min_02","temperature_min_02","WorldClim_2.1_EC-Earth3-Veg_ssp585_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Feb","min T Feb","february","degrees Celsius","*degree*C*", +"temperature_min_03","temperature_min_03","WorldClim_2.1_EC-Earth3-Veg_ssp585_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Mar","min T Mar","march","degrees Celsius","*degree*C*", +"temperature_min_04","temperature_min_04","WorldClim_2.1_EC-Earth3-Veg_ssp585_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Apr","min T Apr","april","degrees Celsius","*degree*C*", +"temperature_min_05","temperature_min_05","WorldClim_2.1_EC-Earth3-Veg_ssp585_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature May","min T May","may","degrees Celsius","*degree*C*", +"temperature_min_06","temperature_min_06","WorldClim_2.1_EC-Earth3-Veg_ssp585_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jun","min T Jun","june","degrees Celsius","*degree*C*", +"temperature_min_07","temperature_min_07","WorldClim_2.1_EC-Earth3-Veg_ssp585_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jul","min T Jul","july","degrees Celsius","*degree*C*", +"temperature_min_08","temperature_min_08","WorldClim_2.1_EC-Earth3-Veg_ssp585_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Aug","min T Aug","august","degrees Celsius","*degree*C*", +"temperature_min_09","temperature_min_09","WorldClim_2.1_EC-Earth3-Veg_ssp585_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Sep","min T Sep","september","degrees Celsius","*degree*C*", +"temperature_min_10","temperature_min_10","WorldClim_2.1_EC-Earth3-Veg_ssp585_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Oct","min T Oct","october","degrees Celsius","*degree*C*", +"temperature_min_11","temperature_min_11","WorldClim_2.1_EC-Earth3-Veg_ssp585_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Nov","min T Nov","november","degrees Celsius","*degree*C*", +"temperature_min_12","temperature_min_12","WorldClim_2.1_EC-Earth3-Veg_ssp585_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Dec","min T Dec","december","degrees Celsius","*degree*C*", +"temperature_max_01","temperature_max_01","WorldClim_2.1_EC-Earth3-Veg_ssp585_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jan","max T Jan","january","degrees Celsius","*degree*C*", +"temperature_max_02","temperature_max_02","WorldClim_2.1_EC-Earth3-Veg_ssp585_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Feb","max T Feb","february","degrees Celsius","*degree*C*", +"temperature_max_03","temperature_max_03","WorldClim_2.1_EC-Earth3-Veg_ssp585_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Mar","max T Mar","march","degrees Celsius","*degree*C*", +"temperature_max_04","temperature_max_04","WorldClim_2.1_EC-Earth3-Veg_ssp585_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Apr","max T Apr","april","degrees Celsius","*degree*C*", +"temperature_max_05","temperature_max_05","WorldClim_2.1_EC-Earth3-Veg_ssp585_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature May","max T May","may","degrees Celsius","*degree*C*", +"temperature_max_06","temperature_max_06","WorldClim_2.1_EC-Earth3-Veg_ssp585_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jun","max T Jun","june","degrees Celsius","*degree*C*", +"temperature_max_07","temperature_max_07","WorldClim_2.1_EC-Earth3-Veg_ssp585_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jul","max T Jul","july","degrees Celsius","*degree*C*", +"temperature_max_08","temperature_max_08","WorldClim_2.1_EC-Earth3-Veg_ssp585_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Aug","max T Aug","august","degrees Celsius","*degree*C*", +"temperature_max_09","temperature_max_09","WorldClim_2.1_EC-Earth3-Veg_ssp585_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Sep","max T Sep","september","degrees Celsius","*degree*C*", +"temperature_max_10","temperature_max_10","WorldClim_2.1_EC-Earth3-Veg_ssp585_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Oct","max T Oct","october","degrees Celsius","*degree*C*", +"temperature_max_11","temperature_max_11","WorldClim_2.1_EC-Earth3-Veg_ssp585_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Nov","max T Nov","november","degrees Celsius","*degree*C*", +"temperature_max_12","temperature_max_12","WorldClim_2.1_EC-Earth3-Veg_ssp585_5m",TRUE,"WorldClim_2.1_EC-Earth3-Veg_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Dec","max T Dec","december","degrees Celsius","*degree*C*", +"bio01","bio01","WorldClim_2.1_FIO-ESM-2-0_ssp126_10m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual mean temperature","ann. mean T","year","degrees Celsius","*degree*C*", +"bio02","bio02","WorldClim_2.1_FIO-ESM-2-0_ssp126_10m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean diurnal range","diurn. range","year","degrees Celsius","*degree*C*", +"bio03","bio03","WorldClim_2.1_FIO-ESM-2-0_ssp126_10m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","isothermality","isothermality","year","","", +"bio04","bio04","WorldClim_2.1_FIO-ESM-2-0_ssp126_10m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature seasonality","T season.","year","degrees Celsius","*degree*C*", +"bio05","bio05","WorldClim_2.1_FIO-ESM-2-0_ssp126_10m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature of warmest month","max. T of warmest mo.","year","degrees Celsius","*degree*C*", +"bio06","bio06","WorldClim_2.1_FIO-ESM-2-0_ssp126_10m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature of coldest month","min. T of coldest mo.","year","degrees Celsius","*degree*C*", +"bio07","bio07","WorldClim_2.1_FIO-ESM-2-0_ssp126_10m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature annual range (bio05-bio06)","T ann. Range","year","degrees Celsius","*degree*C*", +"bio08","bio08","WorldClim_2.1_FIO-ESM-2-0_ssp126_10m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of wettest quarter","mean T of wettest qtr","year","degrees Celsius","*degree*C*", +"bio09","bio09","WorldClim_2.1_FIO-ESM-2-0_ssp126_10m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of driest quarter","mean T of driest qtr","year","degrees Celsius","*degree*C*", +"bio10","bio10","WorldClim_2.1_FIO-ESM-2-0_ssp126_10m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of warmest quarter","mean T of warmest qtr","year","degrees Celsius","*degree*C*", +"bio11","bio11","WorldClim_2.1_FIO-ESM-2-0_ssp126_10m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of coldest quarter","mean T of coldest qtr","year","degrees Celsius","*degree*C*", +"bio12","bio12","WorldClim_2.1_FIO-ESM-2-0_ssp126_10m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual precipitation","ann. P","year","mm per year","*mm~yr^-1*", +"bio13","bio13","WorldClim_2.1_FIO-ESM-2-0_ssp126_10m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest month","P of wettest mo.","year","mm per month","*mm~mo^-1*", +"bio14","bio14","WorldClim_2.1_FIO-ESM-2-0_ssp126_10m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest month","P of driest mo.","year","mm per month","*mm~mo^-1*", +"bio15","bio15","WorldClim_2.1_FIO-ESM-2-0_ssp126_10m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation seasonality (coeff var)","P season.","year","","", +"bio16","bio16","WorldClim_2.1_FIO-ESM-2-0_ssp126_10m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest quarter","P of wettest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio17","bio17","WorldClim_2.1_FIO-ESM-2-0_ssp126_10m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest quarter","P of driest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio18","bio18","WorldClim_2.1_FIO-ESM-2-0_ssp126_10m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of warmest quarter","P of warmest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio19","bio19","WorldClim_2.1_FIO-ESM-2-0_ssp126_10m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of coldest quarter","P of coldest qtr","year","mm per quarter","*mm~qtr^-1*", +"precipitation_01","precipitation_01","WorldClim_2.1_FIO-ESM-2-0_ssp126_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jan","P Jan","january","mm per month","*mm~mo^-1*", +"precipitation_02","precipitation_02","WorldClim_2.1_FIO-ESM-2-0_ssp126_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Feb","P Feb","february","mm per month","*mm~mo^-1*", +"precipitation_03","precipitation_03","WorldClim_2.1_FIO-ESM-2-0_ssp126_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Mar","P Mar","march","mm per month","*mm~mo^-1*", +"precipitation_04","precipitation_04","WorldClim_2.1_FIO-ESM-2-0_ssp126_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Apr","P Apr","april","mm per month","*mm~mo^-1*", +"precipitation_05","precipitation_05","WorldClim_2.1_FIO-ESM-2-0_ssp126_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation May","P May","may","mm per month","*mm~mo^-1*", +"precipitation_06","precipitation_06","WorldClim_2.1_FIO-ESM-2-0_ssp126_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jun","P Jun","june","mm per month","*mm~mo^-1*", +"precipitation_07","precipitation_07","WorldClim_2.1_FIO-ESM-2-0_ssp126_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jul","P Jul","july","mm per month","*mm~mo^-1*", +"precipitation_08","precipitation_08","WorldClim_2.1_FIO-ESM-2-0_ssp126_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Aug","P Aug","august","mm per month","*mm~mo^-1*", +"precipitation_09","precipitation_09","WorldClim_2.1_FIO-ESM-2-0_ssp126_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Sep","P Sep","september","mm per month","*mm~mo^-1*", +"precipitation_10","precipitation_10","WorldClim_2.1_FIO-ESM-2-0_ssp126_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Oct","P Oct","october","mm per month","*mm~mo^-1*", +"precipitation_11","precipitation_11","WorldClim_2.1_FIO-ESM-2-0_ssp126_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Nov","P Nov","november","mm per month","*mm~mo^-1*", +"precipitation_12","precipitation_12","WorldClim_2.1_FIO-ESM-2-0_ssp126_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Dec","P Dec","december","mm per month","*mm~mo^-1*", +"temperature_min_01","temperature_min_01","WorldClim_2.1_FIO-ESM-2-0_ssp126_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jan","min T Jan","january","degrees Celsius","*degree*C*", +"temperature_min_02","temperature_min_02","WorldClim_2.1_FIO-ESM-2-0_ssp126_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Feb","min T Feb","february","degrees Celsius","*degree*C*", +"temperature_min_03","temperature_min_03","WorldClim_2.1_FIO-ESM-2-0_ssp126_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Mar","min T Mar","march","degrees Celsius","*degree*C*", +"temperature_min_04","temperature_min_04","WorldClim_2.1_FIO-ESM-2-0_ssp126_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Apr","min T Apr","april","degrees Celsius","*degree*C*", +"temperature_min_05","temperature_min_05","WorldClim_2.1_FIO-ESM-2-0_ssp126_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature May","min T May","may","degrees Celsius","*degree*C*", +"temperature_min_06","temperature_min_06","WorldClim_2.1_FIO-ESM-2-0_ssp126_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jun","min T Jun","june","degrees Celsius","*degree*C*", +"temperature_min_07","temperature_min_07","WorldClim_2.1_FIO-ESM-2-0_ssp126_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jul","min T Jul","july","degrees Celsius","*degree*C*", +"temperature_min_08","temperature_min_08","WorldClim_2.1_FIO-ESM-2-0_ssp126_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Aug","min T Aug","august","degrees Celsius","*degree*C*", +"temperature_min_09","temperature_min_09","WorldClim_2.1_FIO-ESM-2-0_ssp126_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Sep","min T Sep","september","degrees Celsius","*degree*C*", +"temperature_min_10","temperature_min_10","WorldClim_2.1_FIO-ESM-2-0_ssp126_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Oct","min T Oct","october","degrees Celsius","*degree*C*", +"temperature_min_11","temperature_min_11","WorldClim_2.1_FIO-ESM-2-0_ssp126_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Nov","min T Nov","november","degrees Celsius","*degree*C*", +"temperature_min_12","temperature_min_12","WorldClim_2.1_FIO-ESM-2-0_ssp126_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Dec","min T Dec","december","degrees Celsius","*degree*C*", +"temperature_max_01","temperature_max_01","WorldClim_2.1_FIO-ESM-2-0_ssp126_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jan","max T Jan","january","degrees Celsius","*degree*C*", +"temperature_max_02","temperature_max_02","WorldClim_2.1_FIO-ESM-2-0_ssp126_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Feb","max T Feb","february","degrees Celsius","*degree*C*", +"temperature_max_03","temperature_max_03","WorldClim_2.1_FIO-ESM-2-0_ssp126_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Mar","max T Mar","march","degrees Celsius","*degree*C*", +"temperature_max_04","temperature_max_04","WorldClim_2.1_FIO-ESM-2-0_ssp126_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Apr","max T Apr","april","degrees Celsius","*degree*C*", +"temperature_max_05","temperature_max_05","WorldClim_2.1_FIO-ESM-2-0_ssp126_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature May","max T May","may","degrees Celsius","*degree*C*", +"temperature_max_06","temperature_max_06","WorldClim_2.1_FIO-ESM-2-0_ssp126_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jun","max T Jun","june","degrees Celsius","*degree*C*", +"temperature_max_07","temperature_max_07","WorldClim_2.1_FIO-ESM-2-0_ssp126_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jul","max T Jul","july","degrees Celsius","*degree*C*", +"temperature_max_08","temperature_max_08","WorldClim_2.1_FIO-ESM-2-0_ssp126_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Aug","max T Aug","august","degrees Celsius","*degree*C*", +"temperature_max_09","temperature_max_09","WorldClim_2.1_FIO-ESM-2-0_ssp126_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Sep","max T Sep","september","degrees Celsius","*degree*C*", +"temperature_max_10","temperature_max_10","WorldClim_2.1_FIO-ESM-2-0_ssp126_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Oct","max T Oct","october","degrees Celsius","*degree*C*", +"temperature_max_11","temperature_max_11","WorldClim_2.1_FIO-ESM-2-0_ssp126_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Nov","max T Nov","november","degrees Celsius","*degree*C*", +"temperature_max_12","temperature_max_12","WorldClim_2.1_FIO-ESM-2-0_ssp126_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Dec","max T Dec","december","degrees Celsius","*degree*C*", +"bio01","bio01","WorldClim_2.1_FIO-ESM-2-0_ssp126_5m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual mean temperature","ann. mean T","year","degrees Celsius","*degree*C*", +"bio02","bio02","WorldClim_2.1_FIO-ESM-2-0_ssp126_5m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean diurnal range","diurn. range","year","degrees Celsius","*degree*C*", +"bio03","bio03","WorldClim_2.1_FIO-ESM-2-0_ssp126_5m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","isothermality","isothermality","year","","", +"bio04","bio04","WorldClim_2.1_FIO-ESM-2-0_ssp126_5m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature seasonality","T season.","year","degrees Celsius","*degree*C*", +"bio05","bio05","WorldClim_2.1_FIO-ESM-2-0_ssp126_5m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature of warmest month","max. T of warmest mo.","year","degrees Celsius","*degree*C*", +"bio06","bio06","WorldClim_2.1_FIO-ESM-2-0_ssp126_5m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature of coldest month","min. T of coldest mo.","year","degrees Celsius","*degree*C*", +"bio07","bio07","WorldClim_2.1_FIO-ESM-2-0_ssp126_5m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature annual range (bio05-bio06)","T ann. Range","year","degrees Celsius","*degree*C*", +"bio08","bio08","WorldClim_2.1_FIO-ESM-2-0_ssp126_5m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of wettest quarter","mean T of wettest qtr","year","degrees Celsius","*degree*C*", +"bio09","bio09","WorldClim_2.1_FIO-ESM-2-0_ssp126_5m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of driest quarter","mean T of driest qtr","year","degrees Celsius","*degree*C*", +"bio10","bio10","WorldClim_2.1_FIO-ESM-2-0_ssp126_5m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of warmest quarter","mean T of warmest qtr","year","degrees Celsius","*degree*C*", +"bio11","bio11","WorldClim_2.1_FIO-ESM-2-0_ssp126_5m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of coldest quarter","mean T of coldest qtr","year","degrees Celsius","*degree*C*", +"bio12","bio12","WorldClim_2.1_FIO-ESM-2-0_ssp126_5m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual precipitation","ann. P","year","mm per year","*mm~yr^-1*", +"bio13","bio13","WorldClim_2.1_FIO-ESM-2-0_ssp126_5m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest month","P of wettest mo.","year","mm per month","*mm~mo^-1*", +"bio14","bio14","WorldClim_2.1_FIO-ESM-2-0_ssp126_5m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest month","P of driest mo.","year","mm per month","*mm~mo^-1*", +"bio15","bio15","WorldClim_2.1_FIO-ESM-2-0_ssp126_5m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation seasonality (coeff var)","P season.","year","","", +"bio16","bio16","WorldClim_2.1_FIO-ESM-2-0_ssp126_5m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest quarter","P of wettest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio17","bio17","WorldClim_2.1_FIO-ESM-2-0_ssp126_5m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest quarter","P of driest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio18","bio18","WorldClim_2.1_FIO-ESM-2-0_ssp126_5m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of warmest quarter","P of warmest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio19","bio19","WorldClim_2.1_FIO-ESM-2-0_ssp126_5m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of coldest quarter","P of coldest qtr","year","mm per quarter","*mm~qtr^-1*", +"precipitation_01","precipitation_01","WorldClim_2.1_FIO-ESM-2-0_ssp126_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jan","P Jan","january","mm per month","*mm~mo^-1*", +"precipitation_02","precipitation_02","WorldClim_2.1_FIO-ESM-2-0_ssp126_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Feb","P Feb","february","mm per month","*mm~mo^-1*", +"precipitation_03","precipitation_03","WorldClim_2.1_FIO-ESM-2-0_ssp126_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Mar","P Mar","march","mm per month","*mm~mo^-1*", +"precipitation_04","precipitation_04","WorldClim_2.1_FIO-ESM-2-0_ssp126_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Apr","P Apr","april","mm per month","*mm~mo^-1*", +"precipitation_05","precipitation_05","WorldClim_2.1_FIO-ESM-2-0_ssp126_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation May","P May","may","mm per month","*mm~mo^-1*", +"precipitation_06","precipitation_06","WorldClim_2.1_FIO-ESM-2-0_ssp126_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jun","P Jun","june","mm per month","*mm~mo^-1*", +"precipitation_07","precipitation_07","WorldClim_2.1_FIO-ESM-2-0_ssp126_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jul","P Jul","july","mm per month","*mm~mo^-1*", +"precipitation_08","precipitation_08","WorldClim_2.1_FIO-ESM-2-0_ssp126_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Aug","P Aug","august","mm per month","*mm~mo^-1*", +"precipitation_09","precipitation_09","WorldClim_2.1_FIO-ESM-2-0_ssp126_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Sep","P Sep","september","mm per month","*mm~mo^-1*", +"precipitation_10","precipitation_10","WorldClim_2.1_FIO-ESM-2-0_ssp126_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Oct","P Oct","october","mm per month","*mm~mo^-1*", +"precipitation_11","precipitation_11","WorldClim_2.1_FIO-ESM-2-0_ssp126_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Nov","P Nov","november","mm per month","*mm~mo^-1*", +"precipitation_12","precipitation_12","WorldClim_2.1_FIO-ESM-2-0_ssp126_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Dec","P Dec","december","mm per month","*mm~mo^-1*", +"temperature_min_01","temperature_min_01","WorldClim_2.1_FIO-ESM-2-0_ssp126_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jan","min T Jan","january","degrees Celsius","*degree*C*", +"temperature_min_02","temperature_min_02","WorldClim_2.1_FIO-ESM-2-0_ssp126_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Feb","min T Feb","february","degrees Celsius","*degree*C*", +"temperature_min_03","temperature_min_03","WorldClim_2.1_FIO-ESM-2-0_ssp126_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Mar","min T Mar","march","degrees Celsius","*degree*C*", +"temperature_min_04","temperature_min_04","WorldClim_2.1_FIO-ESM-2-0_ssp126_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Apr","min T Apr","april","degrees Celsius","*degree*C*", +"temperature_min_05","temperature_min_05","WorldClim_2.1_FIO-ESM-2-0_ssp126_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature May","min T May","may","degrees Celsius","*degree*C*", +"temperature_min_06","temperature_min_06","WorldClim_2.1_FIO-ESM-2-0_ssp126_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jun","min T Jun","june","degrees Celsius","*degree*C*", +"temperature_min_07","temperature_min_07","WorldClim_2.1_FIO-ESM-2-0_ssp126_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jul","min T Jul","july","degrees Celsius","*degree*C*", +"temperature_min_08","temperature_min_08","WorldClim_2.1_FIO-ESM-2-0_ssp126_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Aug","min T Aug","august","degrees Celsius","*degree*C*", +"temperature_min_09","temperature_min_09","WorldClim_2.1_FIO-ESM-2-0_ssp126_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Sep","min T Sep","september","degrees Celsius","*degree*C*", +"temperature_min_10","temperature_min_10","WorldClim_2.1_FIO-ESM-2-0_ssp126_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Oct","min T Oct","october","degrees Celsius","*degree*C*", +"temperature_min_11","temperature_min_11","WorldClim_2.1_FIO-ESM-2-0_ssp126_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Nov","min T Nov","november","degrees Celsius","*degree*C*", +"temperature_min_12","temperature_min_12","WorldClim_2.1_FIO-ESM-2-0_ssp126_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Dec","min T Dec","december","degrees Celsius","*degree*C*", +"temperature_max_01","temperature_max_01","WorldClim_2.1_FIO-ESM-2-0_ssp126_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jan","max T Jan","january","degrees Celsius","*degree*C*", +"temperature_max_02","temperature_max_02","WorldClim_2.1_FIO-ESM-2-0_ssp126_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Feb","max T Feb","february","degrees Celsius","*degree*C*", +"temperature_max_03","temperature_max_03","WorldClim_2.1_FIO-ESM-2-0_ssp126_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Mar","max T Mar","march","degrees Celsius","*degree*C*", +"temperature_max_04","temperature_max_04","WorldClim_2.1_FIO-ESM-2-0_ssp126_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Apr","max T Apr","april","degrees Celsius","*degree*C*", +"temperature_max_05","temperature_max_05","WorldClim_2.1_FIO-ESM-2-0_ssp126_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature May","max T May","may","degrees Celsius","*degree*C*", +"temperature_max_06","temperature_max_06","WorldClim_2.1_FIO-ESM-2-0_ssp126_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jun","max T Jun","june","degrees Celsius","*degree*C*", +"temperature_max_07","temperature_max_07","WorldClim_2.1_FIO-ESM-2-0_ssp126_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jul","max T Jul","july","degrees Celsius","*degree*C*", +"temperature_max_08","temperature_max_08","WorldClim_2.1_FIO-ESM-2-0_ssp126_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Aug","max T Aug","august","degrees Celsius","*degree*C*", +"temperature_max_09","temperature_max_09","WorldClim_2.1_FIO-ESM-2-0_ssp126_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Sep","max T Sep","september","degrees Celsius","*degree*C*", +"temperature_max_10","temperature_max_10","WorldClim_2.1_FIO-ESM-2-0_ssp126_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Oct","max T Oct","october","degrees Celsius","*degree*C*", +"temperature_max_11","temperature_max_11","WorldClim_2.1_FIO-ESM-2-0_ssp126_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Nov","max T Nov","november","degrees Celsius","*degree*C*", +"temperature_max_12","temperature_max_12","WorldClim_2.1_FIO-ESM-2-0_ssp126_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Dec","max T Dec","december","degrees Celsius","*degree*C*", +"bio01","bio01","WorldClim_2.1_FIO-ESM-2-0_ssp245_10m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual mean temperature","ann. mean T","year","degrees Celsius","*degree*C*", +"bio02","bio02","WorldClim_2.1_FIO-ESM-2-0_ssp245_10m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean diurnal range","diurn. range","year","degrees Celsius","*degree*C*", +"bio03","bio03","WorldClim_2.1_FIO-ESM-2-0_ssp245_10m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","isothermality","isothermality","year","","", +"bio04","bio04","WorldClim_2.1_FIO-ESM-2-0_ssp245_10m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature seasonality","T season.","year","degrees Celsius","*degree*C*", +"bio05","bio05","WorldClim_2.1_FIO-ESM-2-0_ssp245_10m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature of warmest month","max. T of warmest mo.","year","degrees Celsius","*degree*C*", +"bio06","bio06","WorldClim_2.1_FIO-ESM-2-0_ssp245_10m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature of coldest month","min. T of coldest mo.","year","degrees Celsius","*degree*C*", +"bio07","bio07","WorldClim_2.1_FIO-ESM-2-0_ssp245_10m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature annual range (bio05-bio06)","T ann. Range","year","degrees Celsius","*degree*C*", +"bio08","bio08","WorldClim_2.1_FIO-ESM-2-0_ssp245_10m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of wettest quarter","mean T of wettest qtr","year","degrees Celsius","*degree*C*", +"bio09","bio09","WorldClim_2.1_FIO-ESM-2-0_ssp245_10m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of driest quarter","mean T of driest qtr","year","degrees Celsius","*degree*C*", +"bio10","bio10","WorldClim_2.1_FIO-ESM-2-0_ssp245_10m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of warmest quarter","mean T of warmest qtr","year","degrees Celsius","*degree*C*", +"bio11","bio11","WorldClim_2.1_FIO-ESM-2-0_ssp245_10m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of coldest quarter","mean T of coldest qtr","year","degrees Celsius","*degree*C*", +"bio12","bio12","WorldClim_2.1_FIO-ESM-2-0_ssp245_10m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual precipitation","ann. P","year","mm per year","*mm~yr^-1*", +"bio13","bio13","WorldClim_2.1_FIO-ESM-2-0_ssp245_10m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest month","P of wettest mo.","year","mm per month","*mm~mo^-1*", +"bio14","bio14","WorldClim_2.1_FIO-ESM-2-0_ssp245_10m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest month","P of driest mo.","year","mm per month","*mm~mo^-1*", +"bio15","bio15","WorldClim_2.1_FIO-ESM-2-0_ssp245_10m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation seasonality (coeff var)","P season.","year","","", +"bio16","bio16","WorldClim_2.1_FIO-ESM-2-0_ssp245_10m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest quarter","P of wettest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio17","bio17","WorldClim_2.1_FIO-ESM-2-0_ssp245_10m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest quarter","P of driest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio18","bio18","WorldClim_2.1_FIO-ESM-2-0_ssp245_10m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of warmest quarter","P of warmest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio19","bio19","WorldClim_2.1_FIO-ESM-2-0_ssp245_10m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of coldest quarter","P of coldest qtr","year","mm per quarter","*mm~qtr^-1*", +"precipitation_01","precipitation_01","WorldClim_2.1_FIO-ESM-2-0_ssp245_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jan","P Jan","january","mm per month","*mm~mo^-1*", +"precipitation_02","precipitation_02","WorldClim_2.1_FIO-ESM-2-0_ssp245_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Feb","P Feb","february","mm per month","*mm~mo^-1*", +"precipitation_03","precipitation_03","WorldClim_2.1_FIO-ESM-2-0_ssp245_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Mar","P Mar","march","mm per month","*mm~mo^-1*", +"precipitation_04","precipitation_04","WorldClim_2.1_FIO-ESM-2-0_ssp245_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Apr","P Apr","april","mm per month","*mm~mo^-1*", +"precipitation_05","precipitation_05","WorldClim_2.1_FIO-ESM-2-0_ssp245_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation May","P May","may","mm per month","*mm~mo^-1*", +"precipitation_06","precipitation_06","WorldClim_2.1_FIO-ESM-2-0_ssp245_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jun","P Jun","june","mm per month","*mm~mo^-1*", +"precipitation_07","precipitation_07","WorldClim_2.1_FIO-ESM-2-0_ssp245_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jul","P Jul","july","mm per month","*mm~mo^-1*", +"precipitation_08","precipitation_08","WorldClim_2.1_FIO-ESM-2-0_ssp245_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Aug","P Aug","august","mm per month","*mm~mo^-1*", +"precipitation_09","precipitation_09","WorldClim_2.1_FIO-ESM-2-0_ssp245_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Sep","P Sep","september","mm per month","*mm~mo^-1*", +"precipitation_10","precipitation_10","WorldClim_2.1_FIO-ESM-2-0_ssp245_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Oct","P Oct","october","mm per month","*mm~mo^-1*", +"precipitation_11","precipitation_11","WorldClim_2.1_FIO-ESM-2-0_ssp245_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Nov","P Nov","november","mm per month","*mm~mo^-1*", +"precipitation_12","precipitation_12","WorldClim_2.1_FIO-ESM-2-0_ssp245_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Dec","P Dec","december","mm per month","*mm~mo^-1*", +"temperature_min_01","temperature_min_01","WorldClim_2.1_FIO-ESM-2-0_ssp245_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jan","min T Jan","january","degrees Celsius","*degree*C*", +"temperature_min_02","temperature_min_02","WorldClim_2.1_FIO-ESM-2-0_ssp245_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Feb","min T Feb","february","degrees Celsius","*degree*C*", +"temperature_min_03","temperature_min_03","WorldClim_2.1_FIO-ESM-2-0_ssp245_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Mar","min T Mar","march","degrees Celsius","*degree*C*", +"temperature_min_04","temperature_min_04","WorldClim_2.1_FIO-ESM-2-0_ssp245_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Apr","min T Apr","april","degrees Celsius","*degree*C*", +"temperature_min_05","temperature_min_05","WorldClim_2.1_FIO-ESM-2-0_ssp245_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature May","min T May","may","degrees Celsius","*degree*C*", +"temperature_min_06","temperature_min_06","WorldClim_2.1_FIO-ESM-2-0_ssp245_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jun","min T Jun","june","degrees Celsius","*degree*C*", +"temperature_min_07","temperature_min_07","WorldClim_2.1_FIO-ESM-2-0_ssp245_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jul","min T Jul","july","degrees Celsius","*degree*C*", +"temperature_min_08","temperature_min_08","WorldClim_2.1_FIO-ESM-2-0_ssp245_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Aug","min T Aug","august","degrees Celsius","*degree*C*", +"temperature_min_09","temperature_min_09","WorldClim_2.1_FIO-ESM-2-0_ssp245_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Sep","min T Sep","september","degrees Celsius","*degree*C*", +"temperature_min_10","temperature_min_10","WorldClim_2.1_FIO-ESM-2-0_ssp245_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Oct","min T Oct","october","degrees Celsius","*degree*C*", +"temperature_min_11","temperature_min_11","WorldClim_2.1_FIO-ESM-2-0_ssp245_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Nov","min T Nov","november","degrees Celsius","*degree*C*", +"temperature_min_12","temperature_min_12","WorldClim_2.1_FIO-ESM-2-0_ssp245_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Dec","min T Dec","december","degrees Celsius","*degree*C*", +"temperature_max_01","temperature_max_01","WorldClim_2.1_FIO-ESM-2-0_ssp245_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jan","max T Jan","january","degrees Celsius","*degree*C*", +"temperature_max_02","temperature_max_02","WorldClim_2.1_FIO-ESM-2-0_ssp245_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Feb","max T Feb","february","degrees Celsius","*degree*C*", +"temperature_max_03","temperature_max_03","WorldClim_2.1_FIO-ESM-2-0_ssp245_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Mar","max T Mar","march","degrees Celsius","*degree*C*", +"temperature_max_04","temperature_max_04","WorldClim_2.1_FIO-ESM-2-0_ssp245_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Apr","max T Apr","april","degrees Celsius","*degree*C*", +"temperature_max_05","temperature_max_05","WorldClim_2.1_FIO-ESM-2-0_ssp245_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature May","max T May","may","degrees Celsius","*degree*C*", +"temperature_max_06","temperature_max_06","WorldClim_2.1_FIO-ESM-2-0_ssp245_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jun","max T Jun","june","degrees Celsius","*degree*C*", +"temperature_max_07","temperature_max_07","WorldClim_2.1_FIO-ESM-2-0_ssp245_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jul","max T Jul","july","degrees Celsius","*degree*C*", +"temperature_max_08","temperature_max_08","WorldClim_2.1_FIO-ESM-2-0_ssp245_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Aug","max T Aug","august","degrees Celsius","*degree*C*", +"temperature_max_09","temperature_max_09","WorldClim_2.1_FIO-ESM-2-0_ssp245_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Sep","max T Sep","september","degrees Celsius","*degree*C*", +"temperature_max_10","temperature_max_10","WorldClim_2.1_FIO-ESM-2-0_ssp245_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Oct","max T Oct","october","degrees Celsius","*degree*C*", +"temperature_max_11","temperature_max_11","WorldClim_2.1_FIO-ESM-2-0_ssp245_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Nov","max T Nov","november","degrees Celsius","*degree*C*", +"temperature_max_12","temperature_max_12","WorldClim_2.1_FIO-ESM-2-0_ssp245_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Dec","max T Dec","december","degrees Celsius","*degree*C*", +"bio01","bio01","WorldClim_2.1_FIO-ESM-2-0_ssp245_5m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual mean temperature","ann. mean T","year","degrees Celsius","*degree*C*", +"bio02","bio02","WorldClim_2.1_FIO-ESM-2-0_ssp245_5m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean diurnal range","diurn. range","year","degrees Celsius","*degree*C*", +"bio03","bio03","WorldClim_2.1_FIO-ESM-2-0_ssp245_5m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","isothermality","isothermality","year","","", +"bio04","bio04","WorldClim_2.1_FIO-ESM-2-0_ssp245_5m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature seasonality","T season.","year","degrees Celsius","*degree*C*", +"bio05","bio05","WorldClim_2.1_FIO-ESM-2-0_ssp245_5m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature of warmest month","max. T of warmest mo.","year","degrees Celsius","*degree*C*", +"bio06","bio06","WorldClim_2.1_FIO-ESM-2-0_ssp245_5m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature of coldest month","min. T of coldest mo.","year","degrees Celsius","*degree*C*", +"bio07","bio07","WorldClim_2.1_FIO-ESM-2-0_ssp245_5m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature annual range (bio05-bio06)","T ann. Range","year","degrees Celsius","*degree*C*", +"bio08","bio08","WorldClim_2.1_FIO-ESM-2-0_ssp245_5m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of wettest quarter","mean T of wettest qtr","year","degrees Celsius","*degree*C*", +"bio09","bio09","WorldClim_2.1_FIO-ESM-2-0_ssp245_5m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of driest quarter","mean T of driest qtr","year","degrees Celsius","*degree*C*", +"bio10","bio10","WorldClim_2.1_FIO-ESM-2-0_ssp245_5m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of warmest quarter","mean T of warmest qtr","year","degrees Celsius","*degree*C*", +"bio11","bio11","WorldClim_2.1_FIO-ESM-2-0_ssp245_5m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of coldest quarter","mean T of coldest qtr","year","degrees Celsius","*degree*C*", +"bio12","bio12","WorldClim_2.1_FIO-ESM-2-0_ssp245_5m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual precipitation","ann. P","year","mm per year","*mm~yr^-1*", +"bio13","bio13","WorldClim_2.1_FIO-ESM-2-0_ssp245_5m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest month","P of wettest mo.","year","mm per month","*mm~mo^-1*", +"bio14","bio14","WorldClim_2.1_FIO-ESM-2-0_ssp245_5m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest month","P of driest mo.","year","mm per month","*mm~mo^-1*", +"bio15","bio15","WorldClim_2.1_FIO-ESM-2-0_ssp245_5m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation seasonality (coeff var)","P season.","year","","", +"bio16","bio16","WorldClim_2.1_FIO-ESM-2-0_ssp245_5m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest quarter","P of wettest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio17","bio17","WorldClim_2.1_FIO-ESM-2-0_ssp245_5m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest quarter","P of driest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio18","bio18","WorldClim_2.1_FIO-ESM-2-0_ssp245_5m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of warmest quarter","P of warmest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio19","bio19","WorldClim_2.1_FIO-ESM-2-0_ssp245_5m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of coldest quarter","P of coldest qtr","year","mm per quarter","*mm~qtr^-1*", +"precipitation_01","precipitation_01","WorldClim_2.1_FIO-ESM-2-0_ssp245_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jan","P Jan","january","mm per month","*mm~mo^-1*", +"precipitation_02","precipitation_02","WorldClim_2.1_FIO-ESM-2-0_ssp245_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Feb","P Feb","february","mm per month","*mm~mo^-1*", +"precipitation_03","precipitation_03","WorldClim_2.1_FIO-ESM-2-0_ssp245_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Mar","P Mar","march","mm per month","*mm~mo^-1*", +"precipitation_04","precipitation_04","WorldClim_2.1_FIO-ESM-2-0_ssp245_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Apr","P Apr","april","mm per month","*mm~mo^-1*", +"precipitation_05","precipitation_05","WorldClim_2.1_FIO-ESM-2-0_ssp245_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation May","P May","may","mm per month","*mm~mo^-1*", +"precipitation_06","precipitation_06","WorldClim_2.1_FIO-ESM-2-0_ssp245_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jun","P Jun","june","mm per month","*mm~mo^-1*", +"precipitation_07","precipitation_07","WorldClim_2.1_FIO-ESM-2-0_ssp245_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jul","P Jul","july","mm per month","*mm~mo^-1*", +"precipitation_08","precipitation_08","WorldClim_2.1_FIO-ESM-2-0_ssp245_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Aug","P Aug","august","mm per month","*mm~mo^-1*", +"precipitation_09","precipitation_09","WorldClim_2.1_FIO-ESM-2-0_ssp245_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Sep","P Sep","september","mm per month","*mm~mo^-1*", +"precipitation_10","precipitation_10","WorldClim_2.1_FIO-ESM-2-0_ssp245_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Oct","P Oct","october","mm per month","*mm~mo^-1*", +"precipitation_11","precipitation_11","WorldClim_2.1_FIO-ESM-2-0_ssp245_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Nov","P Nov","november","mm per month","*mm~mo^-1*", +"precipitation_12","precipitation_12","WorldClim_2.1_FIO-ESM-2-0_ssp245_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Dec","P Dec","december","mm per month","*mm~mo^-1*", +"temperature_min_01","temperature_min_01","WorldClim_2.1_FIO-ESM-2-0_ssp245_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jan","min T Jan","january","degrees Celsius","*degree*C*", +"temperature_min_02","temperature_min_02","WorldClim_2.1_FIO-ESM-2-0_ssp245_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Feb","min T Feb","february","degrees Celsius","*degree*C*", +"temperature_min_03","temperature_min_03","WorldClim_2.1_FIO-ESM-2-0_ssp245_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Mar","min T Mar","march","degrees Celsius","*degree*C*", +"temperature_min_04","temperature_min_04","WorldClim_2.1_FIO-ESM-2-0_ssp245_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Apr","min T Apr","april","degrees Celsius","*degree*C*", +"temperature_min_05","temperature_min_05","WorldClim_2.1_FIO-ESM-2-0_ssp245_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature May","min T May","may","degrees Celsius","*degree*C*", +"temperature_min_06","temperature_min_06","WorldClim_2.1_FIO-ESM-2-0_ssp245_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jun","min T Jun","june","degrees Celsius","*degree*C*", +"temperature_min_07","temperature_min_07","WorldClim_2.1_FIO-ESM-2-0_ssp245_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jul","min T Jul","july","degrees Celsius","*degree*C*", +"temperature_min_08","temperature_min_08","WorldClim_2.1_FIO-ESM-2-0_ssp245_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Aug","min T Aug","august","degrees Celsius","*degree*C*", +"temperature_min_09","temperature_min_09","WorldClim_2.1_FIO-ESM-2-0_ssp245_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Sep","min T Sep","september","degrees Celsius","*degree*C*", +"temperature_min_10","temperature_min_10","WorldClim_2.1_FIO-ESM-2-0_ssp245_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Oct","min T Oct","october","degrees Celsius","*degree*C*", +"temperature_min_11","temperature_min_11","WorldClim_2.1_FIO-ESM-2-0_ssp245_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Nov","min T Nov","november","degrees Celsius","*degree*C*", +"temperature_min_12","temperature_min_12","WorldClim_2.1_FIO-ESM-2-0_ssp245_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Dec","min T Dec","december","degrees Celsius","*degree*C*", +"temperature_max_01","temperature_max_01","WorldClim_2.1_FIO-ESM-2-0_ssp245_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jan","max T Jan","january","degrees Celsius","*degree*C*", +"temperature_max_02","temperature_max_02","WorldClim_2.1_FIO-ESM-2-0_ssp245_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Feb","max T Feb","february","degrees Celsius","*degree*C*", +"temperature_max_03","temperature_max_03","WorldClim_2.1_FIO-ESM-2-0_ssp245_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Mar","max T Mar","march","degrees Celsius","*degree*C*", +"temperature_max_04","temperature_max_04","WorldClim_2.1_FIO-ESM-2-0_ssp245_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Apr","max T Apr","april","degrees Celsius","*degree*C*", +"temperature_max_05","temperature_max_05","WorldClim_2.1_FIO-ESM-2-0_ssp245_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature May","max T May","may","degrees Celsius","*degree*C*", +"temperature_max_06","temperature_max_06","WorldClim_2.1_FIO-ESM-2-0_ssp245_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jun","max T Jun","june","degrees Celsius","*degree*C*", +"temperature_max_07","temperature_max_07","WorldClim_2.1_FIO-ESM-2-0_ssp245_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jul","max T Jul","july","degrees Celsius","*degree*C*", +"temperature_max_08","temperature_max_08","WorldClim_2.1_FIO-ESM-2-0_ssp245_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Aug","max T Aug","august","degrees Celsius","*degree*C*", +"temperature_max_09","temperature_max_09","WorldClim_2.1_FIO-ESM-2-0_ssp245_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Sep","max T Sep","september","degrees Celsius","*degree*C*", +"temperature_max_10","temperature_max_10","WorldClim_2.1_FIO-ESM-2-0_ssp245_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Oct","max T Oct","october","degrees Celsius","*degree*C*", +"temperature_max_11","temperature_max_11","WorldClim_2.1_FIO-ESM-2-0_ssp245_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Nov","max T Nov","november","degrees Celsius","*degree*C*", +"temperature_max_12","temperature_max_12","WorldClim_2.1_FIO-ESM-2-0_ssp245_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Dec","max T Dec","december","degrees Celsius","*degree*C*", +"bio01","bio01","WorldClim_2.1_FIO-ESM-2-0_ssp370_10m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual mean temperature","ann. mean T","year","degrees Celsius","*degree*C*", +"bio02","bio02","WorldClim_2.1_FIO-ESM-2-0_ssp370_10m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean diurnal range","diurn. range","year","degrees Celsius","*degree*C*", +"bio03","bio03","WorldClim_2.1_FIO-ESM-2-0_ssp370_10m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","isothermality","isothermality","year","","", +"bio04","bio04","WorldClim_2.1_FIO-ESM-2-0_ssp370_10m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature seasonality","T season.","year","degrees Celsius","*degree*C*", +"bio05","bio05","WorldClim_2.1_FIO-ESM-2-0_ssp370_10m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature of warmest month","max. T of warmest mo.","year","degrees Celsius","*degree*C*", +"bio06","bio06","WorldClim_2.1_FIO-ESM-2-0_ssp370_10m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature of coldest month","min. T of coldest mo.","year","degrees Celsius","*degree*C*", +"bio07","bio07","WorldClim_2.1_FIO-ESM-2-0_ssp370_10m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature annual range (bio05-bio06)","T ann. Range","year","degrees Celsius","*degree*C*", +"bio08","bio08","WorldClim_2.1_FIO-ESM-2-0_ssp370_10m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of wettest quarter","mean T of wettest qtr","year","degrees Celsius","*degree*C*", +"bio09","bio09","WorldClim_2.1_FIO-ESM-2-0_ssp370_10m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of driest quarter","mean T of driest qtr","year","degrees Celsius","*degree*C*", +"bio10","bio10","WorldClim_2.1_FIO-ESM-2-0_ssp370_10m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of warmest quarter","mean T of warmest qtr","year","degrees Celsius","*degree*C*", +"bio11","bio11","WorldClim_2.1_FIO-ESM-2-0_ssp370_10m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of coldest quarter","mean T of coldest qtr","year","degrees Celsius","*degree*C*", +"bio12","bio12","WorldClim_2.1_FIO-ESM-2-0_ssp370_10m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual precipitation","ann. P","year","mm per year","*mm~yr^-1*", +"bio13","bio13","WorldClim_2.1_FIO-ESM-2-0_ssp370_10m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest month","P of wettest mo.","year","mm per month","*mm~mo^-1*", +"bio14","bio14","WorldClim_2.1_FIO-ESM-2-0_ssp370_10m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest month","P of driest mo.","year","mm per month","*mm~mo^-1*", +"bio15","bio15","WorldClim_2.1_FIO-ESM-2-0_ssp370_10m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation seasonality (coeff var)","P season.","year","","", +"bio16","bio16","WorldClim_2.1_FIO-ESM-2-0_ssp370_10m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest quarter","P of wettest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio17","bio17","WorldClim_2.1_FIO-ESM-2-0_ssp370_10m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest quarter","P of driest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio18","bio18","WorldClim_2.1_FIO-ESM-2-0_ssp370_10m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of warmest quarter","P of warmest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio19","bio19","WorldClim_2.1_FIO-ESM-2-0_ssp370_10m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of coldest quarter","P of coldest qtr","year","mm per quarter","*mm~qtr^-1*", +"precipitation_01","precipitation_01","WorldClim_2.1_FIO-ESM-2-0_ssp370_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jan","P Jan","january","mm per month","*mm~mo^-1*", +"precipitation_02","precipitation_02","WorldClim_2.1_FIO-ESM-2-0_ssp370_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Feb","P Feb","february","mm per month","*mm~mo^-1*", +"precipitation_03","precipitation_03","WorldClim_2.1_FIO-ESM-2-0_ssp370_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Mar","P Mar","march","mm per month","*mm~mo^-1*", +"precipitation_04","precipitation_04","WorldClim_2.1_FIO-ESM-2-0_ssp370_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Apr","P Apr","april","mm per month","*mm~mo^-1*", +"precipitation_05","precipitation_05","WorldClim_2.1_FIO-ESM-2-0_ssp370_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation May","P May","may","mm per month","*mm~mo^-1*", +"precipitation_06","precipitation_06","WorldClim_2.1_FIO-ESM-2-0_ssp370_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jun","P Jun","june","mm per month","*mm~mo^-1*", +"precipitation_07","precipitation_07","WorldClim_2.1_FIO-ESM-2-0_ssp370_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jul","P Jul","july","mm per month","*mm~mo^-1*", +"precipitation_08","precipitation_08","WorldClim_2.1_FIO-ESM-2-0_ssp370_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Aug","P Aug","august","mm per month","*mm~mo^-1*", +"precipitation_09","precipitation_09","WorldClim_2.1_FIO-ESM-2-0_ssp370_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Sep","P Sep","september","mm per month","*mm~mo^-1*", +"precipitation_10","precipitation_10","WorldClim_2.1_FIO-ESM-2-0_ssp370_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Oct","P Oct","october","mm per month","*mm~mo^-1*", +"precipitation_11","precipitation_11","WorldClim_2.1_FIO-ESM-2-0_ssp370_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Nov","P Nov","november","mm per month","*mm~mo^-1*", +"precipitation_12","precipitation_12","WorldClim_2.1_FIO-ESM-2-0_ssp370_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Dec","P Dec","december","mm per month","*mm~mo^-1*", +"temperature_min_01","temperature_min_01","WorldClim_2.1_FIO-ESM-2-0_ssp370_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jan","min T Jan","january","degrees Celsius","*degree*C*", +"temperature_min_02","temperature_min_02","WorldClim_2.1_FIO-ESM-2-0_ssp370_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Feb","min T Feb","february","degrees Celsius","*degree*C*", +"temperature_min_03","temperature_min_03","WorldClim_2.1_FIO-ESM-2-0_ssp370_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Mar","min T Mar","march","degrees Celsius","*degree*C*", +"temperature_min_04","temperature_min_04","WorldClim_2.1_FIO-ESM-2-0_ssp370_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Apr","min T Apr","april","degrees Celsius","*degree*C*", +"temperature_min_05","temperature_min_05","WorldClim_2.1_FIO-ESM-2-0_ssp370_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature May","min T May","may","degrees Celsius","*degree*C*", +"temperature_min_06","temperature_min_06","WorldClim_2.1_FIO-ESM-2-0_ssp370_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jun","min T Jun","june","degrees Celsius","*degree*C*", +"temperature_min_07","temperature_min_07","WorldClim_2.1_FIO-ESM-2-0_ssp370_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jul","min T Jul","july","degrees Celsius","*degree*C*", +"temperature_min_08","temperature_min_08","WorldClim_2.1_FIO-ESM-2-0_ssp370_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Aug","min T Aug","august","degrees Celsius","*degree*C*", +"temperature_min_09","temperature_min_09","WorldClim_2.1_FIO-ESM-2-0_ssp370_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Sep","min T Sep","september","degrees Celsius","*degree*C*", +"temperature_min_10","temperature_min_10","WorldClim_2.1_FIO-ESM-2-0_ssp370_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Oct","min T Oct","october","degrees Celsius","*degree*C*", +"temperature_min_11","temperature_min_11","WorldClim_2.1_FIO-ESM-2-0_ssp370_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Nov","min T Nov","november","degrees Celsius","*degree*C*", +"temperature_min_12","temperature_min_12","WorldClim_2.1_FIO-ESM-2-0_ssp370_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Dec","min T Dec","december","degrees Celsius","*degree*C*", +"temperature_max_01","temperature_max_01","WorldClim_2.1_FIO-ESM-2-0_ssp370_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jan","max T Jan","january","degrees Celsius","*degree*C*", +"temperature_max_02","temperature_max_02","WorldClim_2.1_FIO-ESM-2-0_ssp370_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Feb","max T Feb","february","degrees Celsius","*degree*C*", +"temperature_max_03","temperature_max_03","WorldClim_2.1_FIO-ESM-2-0_ssp370_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Mar","max T Mar","march","degrees Celsius","*degree*C*", +"temperature_max_04","temperature_max_04","WorldClim_2.1_FIO-ESM-2-0_ssp370_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Apr","max T Apr","april","degrees Celsius","*degree*C*", +"temperature_max_05","temperature_max_05","WorldClim_2.1_FIO-ESM-2-0_ssp370_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature May","max T May","may","degrees Celsius","*degree*C*", +"temperature_max_06","temperature_max_06","WorldClim_2.1_FIO-ESM-2-0_ssp370_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jun","max T Jun","june","degrees Celsius","*degree*C*", +"temperature_max_07","temperature_max_07","WorldClim_2.1_FIO-ESM-2-0_ssp370_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jul","max T Jul","july","degrees Celsius","*degree*C*", +"temperature_max_08","temperature_max_08","WorldClim_2.1_FIO-ESM-2-0_ssp370_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Aug","max T Aug","august","degrees Celsius","*degree*C*", +"temperature_max_09","temperature_max_09","WorldClim_2.1_FIO-ESM-2-0_ssp370_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Sep","max T Sep","september","degrees Celsius","*degree*C*", +"temperature_max_10","temperature_max_10","WorldClim_2.1_FIO-ESM-2-0_ssp370_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Oct","max T Oct","october","degrees Celsius","*degree*C*", +"temperature_max_11","temperature_max_11","WorldClim_2.1_FIO-ESM-2-0_ssp370_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Nov","max T Nov","november","degrees Celsius","*degree*C*", +"temperature_max_12","temperature_max_12","WorldClim_2.1_FIO-ESM-2-0_ssp370_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Dec","max T Dec","december","degrees Celsius","*degree*C*", +"bio01","bio01","WorldClim_2.1_FIO-ESM-2-0_ssp370_5m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual mean temperature","ann. mean T","year","degrees Celsius","*degree*C*", +"bio02","bio02","WorldClim_2.1_FIO-ESM-2-0_ssp370_5m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean diurnal range","diurn. range","year","degrees Celsius","*degree*C*", +"bio03","bio03","WorldClim_2.1_FIO-ESM-2-0_ssp370_5m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","isothermality","isothermality","year","","", +"bio04","bio04","WorldClim_2.1_FIO-ESM-2-0_ssp370_5m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature seasonality","T season.","year","degrees Celsius","*degree*C*", +"bio05","bio05","WorldClim_2.1_FIO-ESM-2-0_ssp370_5m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature of warmest month","max. T of warmest mo.","year","degrees Celsius","*degree*C*", +"bio06","bio06","WorldClim_2.1_FIO-ESM-2-0_ssp370_5m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature of coldest month","min. T of coldest mo.","year","degrees Celsius","*degree*C*", +"bio07","bio07","WorldClim_2.1_FIO-ESM-2-0_ssp370_5m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature annual range (bio05-bio06)","T ann. Range","year","degrees Celsius","*degree*C*", +"bio08","bio08","WorldClim_2.1_FIO-ESM-2-0_ssp370_5m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of wettest quarter","mean T of wettest qtr","year","degrees Celsius","*degree*C*", +"bio09","bio09","WorldClim_2.1_FIO-ESM-2-0_ssp370_5m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of driest quarter","mean T of driest qtr","year","degrees Celsius","*degree*C*", +"bio10","bio10","WorldClim_2.1_FIO-ESM-2-0_ssp370_5m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of warmest quarter","mean T of warmest qtr","year","degrees Celsius","*degree*C*", +"bio11","bio11","WorldClim_2.1_FIO-ESM-2-0_ssp370_5m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of coldest quarter","mean T of coldest qtr","year","degrees Celsius","*degree*C*", +"bio12","bio12","WorldClim_2.1_FIO-ESM-2-0_ssp370_5m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual precipitation","ann. P","year","mm per year","*mm~yr^-1*", +"bio13","bio13","WorldClim_2.1_FIO-ESM-2-0_ssp370_5m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest month","P of wettest mo.","year","mm per month","*mm~mo^-1*", +"bio14","bio14","WorldClim_2.1_FIO-ESM-2-0_ssp370_5m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest month","P of driest mo.","year","mm per month","*mm~mo^-1*", +"bio15","bio15","WorldClim_2.1_FIO-ESM-2-0_ssp370_5m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation seasonality (coeff var)","P season.","year","","", +"bio16","bio16","WorldClim_2.1_FIO-ESM-2-0_ssp370_5m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest quarter","P of wettest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio17","bio17","WorldClim_2.1_FIO-ESM-2-0_ssp370_5m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest quarter","P of driest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio18","bio18","WorldClim_2.1_FIO-ESM-2-0_ssp370_5m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of warmest quarter","P of warmest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio19","bio19","WorldClim_2.1_FIO-ESM-2-0_ssp370_5m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of coldest quarter","P of coldest qtr","year","mm per quarter","*mm~qtr^-1*", +"precipitation_01","precipitation_01","WorldClim_2.1_FIO-ESM-2-0_ssp370_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jan","P Jan","january","mm per month","*mm~mo^-1*", +"precipitation_02","precipitation_02","WorldClim_2.1_FIO-ESM-2-0_ssp370_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Feb","P Feb","february","mm per month","*mm~mo^-1*", +"precipitation_03","precipitation_03","WorldClim_2.1_FIO-ESM-2-0_ssp370_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Mar","P Mar","march","mm per month","*mm~mo^-1*", +"precipitation_04","precipitation_04","WorldClim_2.1_FIO-ESM-2-0_ssp370_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Apr","P Apr","april","mm per month","*mm~mo^-1*", +"precipitation_05","precipitation_05","WorldClim_2.1_FIO-ESM-2-0_ssp370_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation May","P May","may","mm per month","*mm~mo^-1*", +"precipitation_06","precipitation_06","WorldClim_2.1_FIO-ESM-2-0_ssp370_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jun","P Jun","june","mm per month","*mm~mo^-1*", +"precipitation_07","precipitation_07","WorldClim_2.1_FIO-ESM-2-0_ssp370_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jul","P Jul","july","mm per month","*mm~mo^-1*", +"precipitation_08","precipitation_08","WorldClim_2.1_FIO-ESM-2-0_ssp370_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Aug","P Aug","august","mm per month","*mm~mo^-1*", +"precipitation_09","precipitation_09","WorldClim_2.1_FIO-ESM-2-0_ssp370_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Sep","P Sep","september","mm per month","*mm~mo^-1*", +"precipitation_10","precipitation_10","WorldClim_2.1_FIO-ESM-2-0_ssp370_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Oct","P Oct","october","mm per month","*mm~mo^-1*", +"precipitation_11","precipitation_11","WorldClim_2.1_FIO-ESM-2-0_ssp370_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Nov","P Nov","november","mm per month","*mm~mo^-1*", +"precipitation_12","precipitation_12","WorldClim_2.1_FIO-ESM-2-0_ssp370_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Dec","P Dec","december","mm per month","*mm~mo^-1*", +"temperature_min_01","temperature_min_01","WorldClim_2.1_FIO-ESM-2-0_ssp370_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jan","min T Jan","january","degrees Celsius","*degree*C*", +"temperature_min_02","temperature_min_02","WorldClim_2.1_FIO-ESM-2-0_ssp370_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Feb","min T Feb","february","degrees Celsius","*degree*C*", +"temperature_min_03","temperature_min_03","WorldClim_2.1_FIO-ESM-2-0_ssp370_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Mar","min T Mar","march","degrees Celsius","*degree*C*", +"temperature_min_04","temperature_min_04","WorldClim_2.1_FIO-ESM-2-0_ssp370_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Apr","min T Apr","april","degrees Celsius","*degree*C*", +"temperature_min_05","temperature_min_05","WorldClim_2.1_FIO-ESM-2-0_ssp370_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature May","min T May","may","degrees Celsius","*degree*C*", +"temperature_min_06","temperature_min_06","WorldClim_2.1_FIO-ESM-2-0_ssp370_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jun","min T Jun","june","degrees Celsius","*degree*C*", +"temperature_min_07","temperature_min_07","WorldClim_2.1_FIO-ESM-2-0_ssp370_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jul","min T Jul","july","degrees Celsius","*degree*C*", +"temperature_min_08","temperature_min_08","WorldClim_2.1_FIO-ESM-2-0_ssp370_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Aug","min T Aug","august","degrees Celsius","*degree*C*", +"temperature_min_09","temperature_min_09","WorldClim_2.1_FIO-ESM-2-0_ssp370_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Sep","min T Sep","september","degrees Celsius","*degree*C*", +"temperature_min_10","temperature_min_10","WorldClim_2.1_FIO-ESM-2-0_ssp370_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Oct","min T Oct","october","degrees Celsius","*degree*C*", +"temperature_min_11","temperature_min_11","WorldClim_2.1_FIO-ESM-2-0_ssp370_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Nov","min T Nov","november","degrees Celsius","*degree*C*", +"temperature_min_12","temperature_min_12","WorldClim_2.1_FIO-ESM-2-0_ssp370_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Dec","min T Dec","december","degrees Celsius","*degree*C*", +"temperature_max_01","temperature_max_01","WorldClim_2.1_FIO-ESM-2-0_ssp370_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jan","max T Jan","january","degrees Celsius","*degree*C*", +"temperature_max_02","temperature_max_02","WorldClim_2.1_FIO-ESM-2-0_ssp370_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Feb","max T Feb","february","degrees Celsius","*degree*C*", +"temperature_max_03","temperature_max_03","WorldClim_2.1_FIO-ESM-2-0_ssp370_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Mar","max T Mar","march","degrees Celsius","*degree*C*", +"temperature_max_04","temperature_max_04","WorldClim_2.1_FIO-ESM-2-0_ssp370_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Apr","max T Apr","april","degrees Celsius","*degree*C*", +"temperature_max_05","temperature_max_05","WorldClim_2.1_FIO-ESM-2-0_ssp370_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature May","max T May","may","degrees Celsius","*degree*C*", +"temperature_max_06","temperature_max_06","WorldClim_2.1_FIO-ESM-2-0_ssp370_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jun","max T Jun","june","degrees Celsius","*degree*C*", +"temperature_max_07","temperature_max_07","WorldClim_2.1_FIO-ESM-2-0_ssp370_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jul","max T Jul","july","degrees Celsius","*degree*C*", +"temperature_max_08","temperature_max_08","WorldClim_2.1_FIO-ESM-2-0_ssp370_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Aug","max T Aug","august","degrees Celsius","*degree*C*", +"temperature_max_09","temperature_max_09","WorldClim_2.1_FIO-ESM-2-0_ssp370_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Sep","max T Sep","september","degrees Celsius","*degree*C*", +"temperature_max_10","temperature_max_10","WorldClim_2.1_FIO-ESM-2-0_ssp370_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Oct","max T Oct","october","degrees Celsius","*degree*C*", +"temperature_max_11","temperature_max_11","WorldClim_2.1_FIO-ESM-2-0_ssp370_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Nov","max T Nov","november","degrees Celsius","*degree*C*", +"temperature_max_12","temperature_max_12","WorldClim_2.1_FIO-ESM-2-0_ssp370_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Dec","max T Dec","december","degrees Celsius","*degree*C*", +"bio01","bio01","WorldClim_2.1_FIO-ESM-2-0_ssp585_10m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual mean temperature","ann. mean T","year","degrees Celsius","*degree*C*", +"bio02","bio02","WorldClim_2.1_FIO-ESM-2-0_ssp585_10m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean diurnal range","diurn. range","year","degrees Celsius","*degree*C*", +"bio03","bio03","WorldClim_2.1_FIO-ESM-2-0_ssp585_10m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","isothermality","isothermality","year","","", +"bio04","bio04","WorldClim_2.1_FIO-ESM-2-0_ssp585_10m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature seasonality","T season.","year","degrees Celsius","*degree*C*", +"bio05","bio05","WorldClim_2.1_FIO-ESM-2-0_ssp585_10m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature of warmest month","max. T of warmest mo.","year","degrees Celsius","*degree*C*", +"bio06","bio06","WorldClim_2.1_FIO-ESM-2-0_ssp585_10m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature of coldest month","min. T of coldest mo.","year","degrees Celsius","*degree*C*", +"bio07","bio07","WorldClim_2.1_FIO-ESM-2-0_ssp585_10m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature annual range (bio05-bio06)","T ann. Range","year","degrees Celsius","*degree*C*", +"bio08","bio08","WorldClim_2.1_FIO-ESM-2-0_ssp585_10m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of wettest quarter","mean T of wettest qtr","year","degrees Celsius","*degree*C*", +"bio09","bio09","WorldClim_2.1_FIO-ESM-2-0_ssp585_10m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of driest quarter","mean T of driest qtr","year","degrees Celsius","*degree*C*", +"bio10","bio10","WorldClim_2.1_FIO-ESM-2-0_ssp585_10m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of warmest quarter","mean T of warmest qtr","year","degrees Celsius","*degree*C*", +"bio11","bio11","WorldClim_2.1_FIO-ESM-2-0_ssp585_10m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of coldest quarter","mean T of coldest qtr","year","degrees Celsius","*degree*C*", +"bio12","bio12","WorldClim_2.1_FIO-ESM-2-0_ssp585_10m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual precipitation","ann. P","year","mm per year","*mm~yr^-1*", +"bio13","bio13","WorldClim_2.1_FIO-ESM-2-0_ssp585_10m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest month","P of wettest mo.","year","mm per month","*mm~mo^-1*", +"bio14","bio14","WorldClim_2.1_FIO-ESM-2-0_ssp585_10m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest month","P of driest mo.","year","mm per month","*mm~mo^-1*", +"bio15","bio15","WorldClim_2.1_FIO-ESM-2-0_ssp585_10m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation seasonality (coeff var)","P season.","year","","", +"bio16","bio16","WorldClim_2.1_FIO-ESM-2-0_ssp585_10m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest quarter","P of wettest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio17","bio17","WorldClim_2.1_FIO-ESM-2-0_ssp585_10m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest quarter","P of driest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio18","bio18","WorldClim_2.1_FIO-ESM-2-0_ssp585_10m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of warmest quarter","P of warmest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio19","bio19","WorldClim_2.1_FIO-ESM-2-0_ssp585_10m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of coldest quarter","P of coldest qtr","year","mm per quarter","*mm~qtr^-1*", +"precipitation_01","precipitation_01","WorldClim_2.1_FIO-ESM-2-0_ssp585_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jan","P Jan","january","mm per month","*mm~mo^-1*", +"precipitation_02","precipitation_02","WorldClim_2.1_FIO-ESM-2-0_ssp585_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Feb","P Feb","february","mm per month","*mm~mo^-1*", +"precipitation_03","precipitation_03","WorldClim_2.1_FIO-ESM-2-0_ssp585_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Mar","P Mar","march","mm per month","*mm~mo^-1*", +"precipitation_04","precipitation_04","WorldClim_2.1_FIO-ESM-2-0_ssp585_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Apr","P Apr","april","mm per month","*mm~mo^-1*", +"precipitation_05","precipitation_05","WorldClim_2.1_FIO-ESM-2-0_ssp585_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation May","P May","may","mm per month","*mm~mo^-1*", +"precipitation_06","precipitation_06","WorldClim_2.1_FIO-ESM-2-0_ssp585_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jun","P Jun","june","mm per month","*mm~mo^-1*", +"precipitation_07","precipitation_07","WorldClim_2.1_FIO-ESM-2-0_ssp585_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jul","P Jul","july","mm per month","*mm~mo^-1*", +"precipitation_08","precipitation_08","WorldClim_2.1_FIO-ESM-2-0_ssp585_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Aug","P Aug","august","mm per month","*mm~mo^-1*", +"precipitation_09","precipitation_09","WorldClim_2.1_FIO-ESM-2-0_ssp585_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Sep","P Sep","september","mm per month","*mm~mo^-1*", +"precipitation_10","precipitation_10","WorldClim_2.1_FIO-ESM-2-0_ssp585_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Oct","P Oct","october","mm per month","*mm~mo^-1*", +"precipitation_11","precipitation_11","WorldClim_2.1_FIO-ESM-2-0_ssp585_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Nov","P Nov","november","mm per month","*mm~mo^-1*", +"precipitation_12","precipitation_12","WorldClim_2.1_FIO-ESM-2-0_ssp585_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Dec","P Dec","december","mm per month","*mm~mo^-1*", +"temperature_min_01","temperature_min_01","WorldClim_2.1_FIO-ESM-2-0_ssp585_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jan","min T Jan","january","degrees Celsius","*degree*C*", +"temperature_min_02","temperature_min_02","WorldClim_2.1_FIO-ESM-2-0_ssp585_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Feb","min T Feb","february","degrees Celsius","*degree*C*", +"temperature_min_03","temperature_min_03","WorldClim_2.1_FIO-ESM-2-0_ssp585_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Mar","min T Mar","march","degrees Celsius","*degree*C*", +"temperature_min_04","temperature_min_04","WorldClim_2.1_FIO-ESM-2-0_ssp585_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Apr","min T Apr","april","degrees Celsius","*degree*C*", +"temperature_min_05","temperature_min_05","WorldClim_2.1_FIO-ESM-2-0_ssp585_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature May","min T May","may","degrees Celsius","*degree*C*", +"temperature_min_06","temperature_min_06","WorldClim_2.1_FIO-ESM-2-0_ssp585_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jun","min T Jun","june","degrees Celsius","*degree*C*", +"temperature_min_07","temperature_min_07","WorldClim_2.1_FIO-ESM-2-0_ssp585_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jul","min T Jul","july","degrees Celsius","*degree*C*", +"temperature_min_08","temperature_min_08","WorldClim_2.1_FIO-ESM-2-0_ssp585_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Aug","min T Aug","august","degrees Celsius","*degree*C*", +"temperature_min_09","temperature_min_09","WorldClim_2.1_FIO-ESM-2-0_ssp585_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Sep","min T Sep","september","degrees Celsius","*degree*C*", +"temperature_min_10","temperature_min_10","WorldClim_2.1_FIO-ESM-2-0_ssp585_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Oct","min T Oct","october","degrees Celsius","*degree*C*", +"temperature_min_11","temperature_min_11","WorldClim_2.1_FIO-ESM-2-0_ssp585_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Nov","min T Nov","november","degrees Celsius","*degree*C*", +"temperature_min_12","temperature_min_12","WorldClim_2.1_FIO-ESM-2-0_ssp585_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Dec","min T Dec","december","degrees Celsius","*degree*C*", +"temperature_max_01","temperature_max_01","WorldClim_2.1_FIO-ESM-2-0_ssp585_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jan","max T Jan","january","degrees Celsius","*degree*C*", +"temperature_max_02","temperature_max_02","WorldClim_2.1_FIO-ESM-2-0_ssp585_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Feb","max T Feb","february","degrees Celsius","*degree*C*", +"temperature_max_03","temperature_max_03","WorldClim_2.1_FIO-ESM-2-0_ssp585_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Mar","max T Mar","march","degrees Celsius","*degree*C*", +"temperature_max_04","temperature_max_04","WorldClim_2.1_FIO-ESM-2-0_ssp585_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Apr","max T Apr","april","degrees Celsius","*degree*C*", +"temperature_max_05","temperature_max_05","WorldClim_2.1_FIO-ESM-2-0_ssp585_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature May","max T May","may","degrees Celsius","*degree*C*", +"temperature_max_06","temperature_max_06","WorldClim_2.1_FIO-ESM-2-0_ssp585_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jun","max T Jun","june","degrees Celsius","*degree*C*", +"temperature_max_07","temperature_max_07","WorldClim_2.1_FIO-ESM-2-0_ssp585_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jul","max T Jul","july","degrees Celsius","*degree*C*", +"temperature_max_08","temperature_max_08","WorldClim_2.1_FIO-ESM-2-0_ssp585_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Aug","max T Aug","august","degrees Celsius","*degree*C*", +"temperature_max_09","temperature_max_09","WorldClim_2.1_FIO-ESM-2-0_ssp585_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Sep","max T Sep","september","degrees Celsius","*degree*C*", +"temperature_max_10","temperature_max_10","WorldClim_2.1_FIO-ESM-2-0_ssp585_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Oct","max T Oct","october","degrees Celsius","*degree*C*", +"temperature_max_11","temperature_max_11","WorldClim_2.1_FIO-ESM-2-0_ssp585_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Nov","max T Nov","november","degrees Celsius","*degree*C*", +"temperature_max_12","temperature_max_12","WorldClim_2.1_FIO-ESM-2-0_ssp585_10m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Dec","max T Dec","december","degrees Celsius","*degree*C*", +"bio01","bio01","WorldClim_2.1_FIO-ESM-2-0_ssp585_5m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual mean temperature","ann. mean T","year","degrees Celsius","*degree*C*", +"bio02","bio02","WorldClim_2.1_FIO-ESM-2-0_ssp585_5m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean diurnal range","diurn. range","year","degrees Celsius","*degree*C*", +"bio03","bio03","WorldClim_2.1_FIO-ESM-2-0_ssp585_5m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","isothermality","isothermality","year","","", +"bio04","bio04","WorldClim_2.1_FIO-ESM-2-0_ssp585_5m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature seasonality","T season.","year","degrees Celsius","*degree*C*", +"bio05","bio05","WorldClim_2.1_FIO-ESM-2-0_ssp585_5m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature of warmest month","max. T of warmest mo.","year","degrees Celsius","*degree*C*", +"bio06","bio06","WorldClim_2.1_FIO-ESM-2-0_ssp585_5m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature of coldest month","min. T of coldest mo.","year","degrees Celsius","*degree*C*", +"bio07","bio07","WorldClim_2.1_FIO-ESM-2-0_ssp585_5m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature annual range (bio05-bio06)","T ann. Range","year","degrees Celsius","*degree*C*", +"bio08","bio08","WorldClim_2.1_FIO-ESM-2-0_ssp585_5m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of wettest quarter","mean T of wettest qtr","year","degrees Celsius","*degree*C*", +"bio09","bio09","WorldClim_2.1_FIO-ESM-2-0_ssp585_5m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of driest quarter","mean T of driest qtr","year","degrees Celsius","*degree*C*", +"bio10","bio10","WorldClim_2.1_FIO-ESM-2-0_ssp585_5m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of warmest quarter","mean T of warmest qtr","year","degrees Celsius","*degree*C*", +"bio11","bio11","WorldClim_2.1_FIO-ESM-2-0_ssp585_5m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of coldest quarter","mean T of coldest qtr","year","degrees Celsius","*degree*C*", +"bio12","bio12","WorldClim_2.1_FIO-ESM-2-0_ssp585_5m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual precipitation","ann. P","year","mm per year","*mm~yr^-1*", +"bio13","bio13","WorldClim_2.1_FIO-ESM-2-0_ssp585_5m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest month","P of wettest mo.","year","mm per month","*mm~mo^-1*", +"bio14","bio14","WorldClim_2.1_FIO-ESM-2-0_ssp585_5m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest month","P of driest mo.","year","mm per month","*mm~mo^-1*", +"bio15","bio15","WorldClim_2.1_FIO-ESM-2-0_ssp585_5m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation seasonality (coeff var)","P season.","year","","", +"bio16","bio16","WorldClim_2.1_FIO-ESM-2-0_ssp585_5m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest quarter","P of wettest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio17","bio17","WorldClim_2.1_FIO-ESM-2-0_ssp585_5m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest quarter","P of driest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio18","bio18","WorldClim_2.1_FIO-ESM-2-0_ssp585_5m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of warmest quarter","P of warmest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio19","bio19","WorldClim_2.1_FIO-ESM-2-0_ssp585_5m",FALSE,"WorldClim_2.1_FIO-ESM-2-0_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of coldest quarter","P of coldest qtr","year","mm per quarter","*mm~qtr^-1*", +"precipitation_01","precipitation_01","WorldClim_2.1_FIO-ESM-2-0_ssp585_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jan","P Jan","january","mm per month","*mm~mo^-1*", +"precipitation_02","precipitation_02","WorldClim_2.1_FIO-ESM-2-0_ssp585_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Feb","P Feb","february","mm per month","*mm~mo^-1*", +"precipitation_03","precipitation_03","WorldClim_2.1_FIO-ESM-2-0_ssp585_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Mar","P Mar","march","mm per month","*mm~mo^-1*", +"precipitation_04","precipitation_04","WorldClim_2.1_FIO-ESM-2-0_ssp585_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Apr","P Apr","april","mm per month","*mm~mo^-1*", +"precipitation_05","precipitation_05","WorldClim_2.1_FIO-ESM-2-0_ssp585_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation May","P May","may","mm per month","*mm~mo^-1*", +"precipitation_06","precipitation_06","WorldClim_2.1_FIO-ESM-2-0_ssp585_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jun","P Jun","june","mm per month","*mm~mo^-1*", +"precipitation_07","precipitation_07","WorldClim_2.1_FIO-ESM-2-0_ssp585_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jul","P Jul","july","mm per month","*mm~mo^-1*", +"precipitation_08","precipitation_08","WorldClim_2.1_FIO-ESM-2-0_ssp585_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Aug","P Aug","august","mm per month","*mm~mo^-1*", +"precipitation_09","precipitation_09","WorldClim_2.1_FIO-ESM-2-0_ssp585_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Sep","P Sep","september","mm per month","*mm~mo^-1*", +"precipitation_10","precipitation_10","WorldClim_2.1_FIO-ESM-2-0_ssp585_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Oct","P Oct","october","mm per month","*mm~mo^-1*", +"precipitation_11","precipitation_11","WorldClim_2.1_FIO-ESM-2-0_ssp585_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Nov","P Nov","november","mm per month","*mm~mo^-1*", +"precipitation_12","precipitation_12","WorldClim_2.1_FIO-ESM-2-0_ssp585_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Dec","P Dec","december","mm per month","*mm~mo^-1*", +"temperature_min_01","temperature_min_01","WorldClim_2.1_FIO-ESM-2-0_ssp585_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jan","min T Jan","january","degrees Celsius","*degree*C*", +"temperature_min_02","temperature_min_02","WorldClim_2.1_FIO-ESM-2-0_ssp585_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Feb","min T Feb","february","degrees Celsius","*degree*C*", +"temperature_min_03","temperature_min_03","WorldClim_2.1_FIO-ESM-2-0_ssp585_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Mar","min T Mar","march","degrees Celsius","*degree*C*", +"temperature_min_04","temperature_min_04","WorldClim_2.1_FIO-ESM-2-0_ssp585_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Apr","min T Apr","april","degrees Celsius","*degree*C*", +"temperature_min_05","temperature_min_05","WorldClim_2.1_FIO-ESM-2-0_ssp585_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature May","min T May","may","degrees Celsius","*degree*C*", +"temperature_min_06","temperature_min_06","WorldClim_2.1_FIO-ESM-2-0_ssp585_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jun","min T Jun","june","degrees Celsius","*degree*C*", +"temperature_min_07","temperature_min_07","WorldClim_2.1_FIO-ESM-2-0_ssp585_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jul","min T Jul","july","degrees Celsius","*degree*C*", +"temperature_min_08","temperature_min_08","WorldClim_2.1_FIO-ESM-2-0_ssp585_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Aug","min T Aug","august","degrees Celsius","*degree*C*", +"temperature_min_09","temperature_min_09","WorldClim_2.1_FIO-ESM-2-0_ssp585_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Sep","min T Sep","september","degrees Celsius","*degree*C*", +"temperature_min_10","temperature_min_10","WorldClim_2.1_FIO-ESM-2-0_ssp585_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Oct","min T Oct","october","degrees Celsius","*degree*C*", +"temperature_min_11","temperature_min_11","WorldClim_2.1_FIO-ESM-2-0_ssp585_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Nov","min T Nov","november","degrees Celsius","*degree*C*", +"temperature_min_12","temperature_min_12","WorldClim_2.1_FIO-ESM-2-0_ssp585_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Dec","min T Dec","december","degrees Celsius","*degree*C*", +"temperature_max_01","temperature_max_01","WorldClim_2.1_FIO-ESM-2-0_ssp585_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jan","max T Jan","january","degrees Celsius","*degree*C*", +"temperature_max_02","temperature_max_02","WorldClim_2.1_FIO-ESM-2-0_ssp585_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Feb","max T Feb","february","degrees Celsius","*degree*C*", +"temperature_max_03","temperature_max_03","WorldClim_2.1_FIO-ESM-2-0_ssp585_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Mar","max T Mar","march","degrees Celsius","*degree*C*", +"temperature_max_04","temperature_max_04","WorldClim_2.1_FIO-ESM-2-0_ssp585_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Apr","max T Apr","april","degrees Celsius","*degree*C*", +"temperature_max_05","temperature_max_05","WorldClim_2.1_FIO-ESM-2-0_ssp585_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature May","max T May","may","degrees Celsius","*degree*C*", +"temperature_max_06","temperature_max_06","WorldClim_2.1_FIO-ESM-2-0_ssp585_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jun","max T Jun","june","degrees Celsius","*degree*C*", +"temperature_max_07","temperature_max_07","WorldClim_2.1_FIO-ESM-2-0_ssp585_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jul","max T Jul","july","degrees Celsius","*degree*C*", +"temperature_max_08","temperature_max_08","WorldClim_2.1_FIO-ESM-2-0_ssp585_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Aug","max T Aug","august","degrees Celsius","*degree*C*", +"temperature_max_09","temperature_max_09","WorldClim_2.1_FIO-ESM-2-0_ssp585_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Sep","max T Sep","september","degrees Celsius","*degree*C*", +"temperature_max_10","temperature_max_10","WorldClim_2.1_FIO-ESM-2-0_ssp585_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Oct","max T Oct","october","degrees Celsius","*degree*C*", +"temperature_max_11","temperature_max_11","WorldClim_2.1_FIO-ESM-2-0_ssp585_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Nov","max T Nov","november","degrees Celsius","*degree*C*", +"temperature_max_12","temperature_max_12","WorldClim_2.1_FIO-ESM-2-0_ssp585_5m",TRUE,"WorldClim_2.1_FIO-ESM-2-0_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Dec","max T Dec","december","degrees Celsius","*degree*C*", +"bio01","bio01","WorldClim_2.1_GFDL-ESM4_ssp126_10m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual mean temperature","ann. mean T","year","degrees Celsius","*degree*C*", +"bio02","bio02","WorldClim_2.1_GFDL-ESM4_ssp126_10m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean diurnal range","diurn. range","year","degrees Celsius","*degree*C*", +"bio03","bio03","WorldClim_2.1_GFDL-ESM4_ssp126_10m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","isothermality","isothermality","year","","", +"bio04","bio04","WorldClim_2.1_GFDL-ESM4_ssp126_10m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature seasonality","T season.","year","degrees Celsius","*degree*C*", +"bio05","bio05","WorldClim_2.1_GFDL-ESM4_ssp126_10m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature of warmest month","max. T of warmest mo.","year","degrees Celsius","*degree*C*", +"bio06","bio06","WorldClim_2.1_GFDL-ESM4_ssp126_10m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature of coldest month","min. T of coldest mo.","year","degrees Celsius","*degree*C*", +"bio07","bio07","WorldClim_2.1_GFDL-ESM4_ssp126_10m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature annual range (bio05-bio06)","T ann. Range","year","degrees Celsius","*degree*C*", +"bio08","bio08","WorldClim_2.1_GFDL-ESM4_ssp126_10m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of wettest quarter","mean T of wettest qtr","year","degrees Celsius","*degree*C*", +"bio09","bio09","WorldClim_2.1_GFDL-ESM4_ssp126_10m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of driest quarter","mean T of driest qtr","year","degrees Celsius","*degree*C*", +"bio10","bio10","WorldClim_2.1_GFDL-ESM4_ssp126_10m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of warmest quarter","mean T of warmest qtr","year","degrees Celsius","*degree*C*", +"bio11","bio11","WorldClim_2.1_GFDL-ESM4_ssp126_10m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of coldest quarter","mean T of coldest qtr","year","degrees Celsius","*degree*C*", +"bio12","bio12","WorldClim_2.1_GFDL-ESM4_ssp126_10m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual precipitation","ann. P","year","mm per year","*mm~yr^-1*", +"bio13","bio13","WorldClim_2.1_GFDL-ESM4_ssp126_10m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest month","P of wettest mo.","year","mm per month","*mm~mo^-1*", +"bio14","bio14","WorldClim_2.1_GFDL-ESM4_ssp126_10m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest month","P of driest mo.","year","mm per month","*mm~mo^-1*", +"bio15","bio15","WorldClim_2.1_GFDL-ESM4_ssp126_10m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation seasonality (coeff var)","P season.","year","","", +"bio16","bio16","WorldClim_2.1_GFDL-ESM4_ssp126_10m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest quarter","P of wettest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio17","bio17","WorldClim_2.1_GFDL-ESM4_ssp126_10m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest quarter","P of driest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio18","bio18","WorldClim_2.1_GFDL-ESM4_ssp126_10m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of warmest quarter","P of warmest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio19","bio19","WorldClim_2.1_GFDL-ESM4_ssp126_10m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of coldest quarter","P of coldest qtr","year","mm per quarter","*mm~qtr^-1*", +"precipitation_01","precipitation_01","WorldClim_2.1_GFDL-ESM4_ssp126_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jan","P Jan","january","mm per month","*mm~mo^-1*", +"precipitation_02","precipitation_02","WorldClim_2.1_GFDL-ESM4_ssp126_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Feb","P Feb","february","mm per month","*mm~mo^-1*", +"precipitation_03","precipitation_03","WorldClim_2.1_GFDL-ESM4_ssp126_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Mar","P Mar","march","mm per month","*mm~mo^-1*", +"precipitation_04","precipitation_04","WorldClim_2.1_GFDL-ESM4_ssp126_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Apr","P Apr","april","mm per month","*mm~mo^-1*", +"precipitation_05","precipitation_05","WorldClim_2.1_GFDL-ESM4_ssp126_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation May","P May","may","mm per month","*mm~mo^-1*", +"precipitation_06","precipitation_06","WorldClim_2.1_GFDL-ESM4_ssp126_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jun","P Jun","june","mm per month","*mm~mo^-1*", +"precipitation_07","precipitation_07","WorldClim_2.1_GFDL-ESM4_ssp126_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jul","P Jul","july","mm per month","*mm~mo^-1*", +"precipitation_08","precipitation_08","WorldClim_2.1_GFDL-ESM4_ssp126_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Aug","P Aug","august","mm per month","*mm~mo^-1*", +"precipitation_09","precipitation_09","WorldClim_2.1_GFDL-ESM4_ssp126_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Sep","P Sep","september","mm per month","*mm~mo^-1*", +"precipitation_10","precipitation_10","WorldClim_2.1_GFDL-ESM4_ssp126_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Oct","P Oct","october","mm per month","*mm~mo^-1*", +"precipitation_11","precipitation_11","WorldClim_2.1_GFDL-ESM4_ssp126_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Nov","P Nov","november","mm per month","*mm~mo^-1*", +"precipitation_12","precipitation_12","WorldClim_2.1_GFDL-ESM4_ssp126_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Dec","P Dec","december","mm per month","*mm~mo^-1*", +"temperature_min_01","temperature_min_01","WorldClim_2.1_GFDL-ESM4_ssp126_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jan","min T Jan","january","degrees Celsius","*degree*C*", +"temperature_min_02","temperature_min_02","WorldClim_2.1_GFDL-ESM4_ssp126_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Feb","min T Feb","february","degrees Celsius","*degree*C*", +"temperature_min_03","temperature_min_03","WorldClim_2.1_GFDL-ESM4_ssp126_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Mar","min T Mar","march","degrees Celsius","*degree*C*", +"temperature_min_04","temperature_min_04","WorldClim_2.1_GFDL-ESM4_ssp126_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Apr","min T Apr","april","degrees Celsius","*degree*C*", +"temperature_min_05","temperature_min_05","WorldClim_2.1_GFDL-ESM4_ssp126_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature May","min T May","may","degrees Celsius","*degree*C*", +"temperature_min_06","temperature_min_06","WorldClim_2.1_GFDL-ESM4_ssp126_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jun","min T Jun","june","degrees Celsius","*degree*C*", +"temperature_min_07","temperature_min_07","WorldClim_2.1_GFDL-ESM4_ssp126_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jul","min T Jul","july","degrees Celsius","*degree*C*", +"temperature_min_08","temperature_min_08","WorldClim_2.1_GFDL-ESM4_ssp126_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Aug","min T Aug","august","degrees Celsius","*degree*C*", +"temperature_min_09","temperature_min_09","WorldClim_2.1_GFDL-ESM4_ssp126_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Sep","min T Sep","september","degrees Celsius","*degree*C*", +"temperature_min_10","temperature_min_10","WorldClim_2.1_GFDL-ESM4_ssp126_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Oct","min T Oct","october","degrees Celsius","*degree*C*", +"temperature_min_11","temperature_min_11","WorldClim_2.1_GFDL-ESM4_ssp126_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Nov","min T Nov","november","degrees Celsius","*degree*C*", +"temperature_min_12","temperature_min_12","WorldClim_2.1_GFDL-ESM4_ssp126_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Dec","min T Dec","december","degrees Celsius","*degree*C*", +"temperature_max_01","temperature_max_01","WorldClim_2.1_GFDL-ESM4_ssp126_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jan","max T Jan","january","degrees Celsius","*degree*C*", +"temperature_max_02","temperature_max_02","WorldClim_2.1_GFDL-ESM4_ssp126_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Feb","max T Feb","february","degrees Celsius","*degree*C*", +"temperature_max_03","temperature_max_03","WorldClim_2.1_GFDL-ESM4_ssp126_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Mar","max T Mar","march","degrees Celsius","*degree*C*", +"temperature_max_04","temperature_max_04","WorldClim_2.1_GFDL-ESM4_ssp126_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Apr","max T Apr","april","degrees Celsius","*degree*C*", +"temperature_max_05","temperature_max_05","WorldClim_2.1_GFDL-ESM4_ssp126_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature May","max T May","may","degrees Celsius","*degree*C*", +"temperature_max_06","temperature_max_06","WorldClim_2.1_GFDL-ESM4_ssp126_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jun","max T Jun","june","degrees Celsius","*degree*C*", +"temperature_max_07","temperature_max_07","WorldClim_2.1_GFDL-ESM4_ssp126_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jul","max T Jul","july","degrees Celsius","*degree*C*", +"temperature_max_08","temperature_max_08","WorldClim_2.1_GFDL-ESM4_ssp126_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Aug","max T Aug","august","degrees Celsius","*degree*C*", +"temperature_max_09","temperature_max_09","WorldClim_2.1_GFDL-ESM4_ssp126_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Sep","max T Sep","september","degrees Celsius","*degree*C*", +"temperature_max_10","temperature_max_10","WorldClim_2.1_GFDL-ESM4_ssp126_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Oct","max T Oct","october","degrees Celsius","*degree*C*", +"temperature_max_11","temperature_max_11","WorldClim_2.1_GFDL-ESM4_ssp126_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Nov","max T Nov","november","degrees Celsius","*degree*C*", +"temperature_max_12","temperature_max_12","WorldClim_2.1_GFDL-ESM4_ssp126_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Dec","max T Dec","december","degrees Celsius","*degree*C*", +"bio01","bio01","WorldClim_2.1_GFDL-ESM4_ssp126_5m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual mean temperature","ann. mean T","year","degrees Celsius","*degree*C*", +"bio02","bio02","WorldClim_2.1_GFDL-ESM4_ssp126_5m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean diurnal range","diurn. range","year","degrees Celsius","*degree*C*", +"bio03","bio03","WorldClim_2.1_GFDL-ESM4_ssp126_5m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","isothermality","isothermality","year","","", +"bio04","bio04","WorldClim_2.1_GFDL-ESM4_ssp126_5m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature seasonality","T season.","year","degrees Celsius","*degree*C*", +"bio05","bio05","WorldClim_2.1_GFDL-ESM4_ssp126_5m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature of warmest month","max. T of warmest mo.","year","degrees Celsius","*degree*C*", +"bio06","bio06","WorldClim_2.1_GFDL-ESM4_ssp126_5m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature of coldest month","min. T of coldest mo.","year","degrees Celsius","*degree*C*", +"bio07","bio07","WorldClim_2.1_GFDL-ESM4_ssp126_5m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature annual range (bio05-bio06)","T ann. Range","year","degrees Celsius","*degree*C*", +"bio08","bio08","WorldClim_2.1_GFDL-ESM4_ssp126_5m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of wettest quarter","mean T of wettest qtr","year","degrees Celsius","*degree*C*", +"bio09","bio09","WorldClim_2.1_GFDL-ESM4_ssp126_5m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of driest quarter","mean T of driest qtr","year","degrees Celsius","*degree*C*", +"bio10","bio10","WorldClim_2.1_GFDL-ESM4_ssp126_5m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of warmest quarter","mean T of warmest qtr","year","degrees Celsius","*degree*C*", +"bio11","bio11","WorldClim_2.1_GFDL-ESM4_ssp126_5m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of coldest quarter","mean T of coldest qtr","year","degrees Celsius","*degree*C*", +"bio12","bio12","WorldClim_2.1_GFDL-ESM4_ssp126_5m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual precipitation","ann. P","year","mm per year","*mm~yr^-1*", +"bio13","bio13","WorldClim_2.1_GFDL-ESM4_ssp126_5m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest month","P of wettest mo.","year","mm per month","*mm~mo^-1*", +"bio14","bio14","WorldClim_2.1_GFDL-ESM4_ssp126_5m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest month","P of driest mo.","year","mm per month","*mm~mo^-1*", +"bio15","bio15","WorldClim_2.1_GFDL-ESM4_ssp126_5m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation seasonality (coeff var)","P season.","year","","", +"bio16","bio16","WorldClim_2.1_GFDL-ESM4_ssp126_5m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest quarter","P of wettest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio17","bio17","WorldClim_2.1_GFDL-ESM4_ssp126_5m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest quarter","P of driest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio18","bio18","WorldClim_2.1_GFDL-ESM4_ssp126_5m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of warmest quarter","P of warmest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio19","bio19","WorldClim_2.1_GFDL-ESM4_ssp126_5m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of coldest quarter","P of coldest qtr","year","mm per quarter","*mm~qtr^-1*", +"precipitation_01","precipitation_01","WorldClim_2.1_GFDL-ESM4_ssp126_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jan","P Jan","january","mm per month","*mm~mo^-1*", +"precipitation_02","precipitation_02","WorldClim_2.1_GFDL-ESM4_ssp126_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Feb","P Feb","february","mm per month","*mm~mo^-1*", +"precipitation_03","precipitation_03","WorldClim_2.1_GFDL-ESM4_ssp126_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Mar","P Mar","march","mm per month","*mm~mo^-1*", +"precipitation_04","precipitation_04","WorldClim_2.1_GFDL-ESM4_ssp126_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Apr","P Apr","april","mm per month","*mm~mo^-1*", +"precipitation_05","precipitation_05","WorldClim_2.1_GFDL-ESM4_ssp126_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation May","P May","may","mm per month","*mm~mo^-1*", +"precipitation_06","precipitation_06","WorldClim_2.1_GFDL-ESM4_ssp126_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jun","P Jun","june","mm per month","*mm~mo^-1*", +"precipitation_07","precipitation_07","WorldClim_2.1_GFDL-ESM4_ssp126_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jul","P Jul","july","mm per month","*mm~mo^-1*", +"precipitation_08","precipitation_08","WorldClim_2.1_GFDL-ESM4_ssp126_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Aug","P Aug","august","mm per month","*mm~mo^-1*", +"precipitation_09","precipitation_09","WorldClim_2.1_GFDL-ESM4_ssp126_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Sep","P Sep","september","mm per month","*mm~mo^-1*", +"precipitation_10","precipitation_10","WorldClim_2.1_GFDL-ESM4_ssp126_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Oct","P Oct","october","mm per month","*mm~mo^-1*", +"precipitation_11","precipitation_11","WorldClim_2.1_GFDL-ESM4_ssp126_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Nov","P Nov","november","mm per month","*mm~mo^-1*", +"precipitation_12","precipitation_12","WorldClim_2.1_GFDL-ESM4_ssp126_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Dec","P Dec","december","mm per month","*mm~mo^-1*", +"temperature_min_01","temperature_min_01","WorldClim_2.1_GFDL-ESM4_ssp126_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jan","min T Jan","january","degrees Celsius","*degree*C*", +"temperature_min_02","temperature_min_02","WorldClim_2.1_GFDL-ESM4_ssp126_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Feb","min T Feb","february","degrees Celsius","*degree*C*", +"temperature_min_03","temperature_min_03","WorldClim_2.1_GFDL-ESM4_ssp126_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Mar","min T Mar","march","degrees Celsius","*degree*C*", +"temperature_min_04","temperature_min_04","WorldClim_2.1_GFDL-ESM4_ssp126_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Apr","min T Apr","april","degrees Celsius","*degree*C*", +"temperature_min_05","temperature_min_05","WorldClim_2.1_GFDL-ESM4_ssp126_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature May","min T May","may","degrees Celsius","*degree*C*", +"temperature_min_06","temperature_min_06","WorldClim_2.1_GFDL-ESM4_ssp126_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jun","min T Jun","june","degrees Celsius","*degree*C*", +"temperature_min_07","temperature_min_07","WorldClim_2.1_GFDL-ESM4_ssp126_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jul","min T Jul","july","degrees Celsius","*degree*C*", +"temperature_min_08","temperature_min_08","WorldClim_2.1_GFDL-ESM4_ssp126_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Aug","min T Aug","august","degrees Celsius","*degree*C*", +"temperature_min_09","temperature_min_09","WorldClim_2.1_GFDL-ESM4_ssp126_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Sep","min T Sep","september","degrees Celsius","*degree*C*", +"temperature_min_10","temperature_min_10","WorldClim_2.1_GFDL-ESM4_ssp126_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Oct","min T Oct","october","degrees Celsius","*degree*C*", +"temperature_min_11","temperature_min_11","WorldClim_2.1_GFDL-ESM4_ssp126_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Nov","min T Nov","november","degrees Celsius","*degree*C*", +"temperature_min_12","temperature_min_12","WorldClim_2.1_GFDL-ESM4_ssp126_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Dec","min T Dec","december","degrees Celsius","*degree*C*", +"temperature_max_01","temperature_max_01","WorldClim_2.1_GFDL-ESM4_ssp126_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jan","max T Jan","january","degrees Celsius","*degree*C*", +"temperature_max_02","temperature_max_02","WorldClim_2.1_GFDL-ESM4_ssp126_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Feb","max T Feb","february","degrees Celsius","*degree*C*", +"temperature_max_03","temperature_max_03","WorldClim_2.1_GFDL-ESM4_ssp126_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Mar","max T Mar","march","degrees Celsius","*degree*C*", +"temperature_max_04","temperature_max_04","WorldClim_2.1_GFDL-ESM4_ssp126_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Apr","max T Apr","april","degrees Celsius","*degree*C*", +"temperature_max_05","temperature_max_05","WorldClim_2.1_GFDL-ESM4_ssp126_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature May","max T May","may","degrees Celsius","*degree*C*", +"temperature_max_06","temperature_max_06","WorldClim_2.1_GFDL-ESM4_ssp126_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jun","max T Jun","june","degrees Celsius","*degree*C*", +"temperature_max_07","temperature_max_07","WorldClim_2.1_GFDL-ESM4_ssp126_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jul","max T Jul","july","degrees Celsius","*degree*C*", +"temperature_max_08","temperature_max_08","WorldClim_2.1_GFDL-ESM4_ssp126_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Aug","max T Aug","august","degrees Celsius","*degree*C*", +"temperature_max_09","temperature_max_09","WorldClim_2.1_GFDL-ESM4_ssp126_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Sep","max T Sep","september","degrees Celsius","*degree*C*", +"temperature_max_10","temperature_max_10","WorldClim_2.1_GFDL-ESM4_ssp126_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Oct","max T Oct","october","degrees Celsius","*degree*C*", +"temperature_max_11","temperature_max_11","WorldClim_2.1_GFDL-ESM4_ssp126_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Nov","max T Nov","november","degrees Celsius","*degree*C*", +"temperature_max_12","temperature_max_12","WorldClim_2.1_GFDL-ESM4_ssp126_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Dec","max T Dec","december","degrees Celsius","*degree*C*", +"bio01","bio01","WorldClim_2.1_GFDL-ESM4_ssp245_10m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual mean temperature","ann. mean T","year","degrees Celsius","*degree*C*", +"bio02","bio02","WorldClim_2.1_GFDL-ESM4_ssp245_10m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean diurnal range","diurn. range","year","degrees Celsius","*degree*C*", +"bio03","bio03","WorldClim_2.1_GFDL-ESM4_ssp245_10m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","isothermality","isothermality","year","","", +"bio04","bio04","WorldClim_2.1_GFDL-ESM4_ssp245_10m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature seasonality","T season.","year","degrees Celsius","*degree*C*", +"bio05","bio05","WorldClim_2.1_GFDL-ESM4_ssp245_10m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature of warmest month","max. T of warmest mo.","year","degrees Celsius","*degree*C*", +"bio06","bio06","WorldClim_2.1_GFDL-ESM4_ssp245_10m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature of coldest month","min. T of coldest mo.","year","degrees Celsius","*degree*C*", +"bio07","bio07","WorldClim_2.1_GFDL-ESM4_ssp245_10m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature annual range (bio05-bio06)","T ann. Range","year","degrees Celsius","*degree*C*", +"bio08","bio08","WorldClim_2.1_GFDL-ESM4_ssp245_10m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of wettest quarter","mean T of wettest qtr","year","degrees Celsius","*degree*C*", +"bio09","bio09","WorldClim_2.1_GFDL-ESM4_ssp245_10m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of driest quarter","mean T of driest qtr","year","degrees Celsius","*degree*C*", +"bio10","bio10","WorldClim_2.1_GFDL-ESM4_ssp245_10m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of warmest quarter","mean T of warmest qtr","year","degrees Celsius","*degree*C*", +"bio11","bio11","WorldClim_2.1_GFDL-ESM4_ssp245_10m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of coldest quarter","mean T of coldest qtr","year","degrees Celsius","*degree*C*", +"bio12","bio12","WorldClim_2.1_GFDL-ESM4_ssp245_10m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual precipitation","ann. P","year","mm per year","*mm~yr^-1*", +"bio13","bio13","WorldClim_2.1_GFDL-ESM4_ssp245_10m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest month","P of wettest mo.","year","mm per month","*mm~mo^-1*", +"bio14","bio14","WorldClim_2.1_GFDL-ESM4_ssp245_10m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest month","P of driest mo.","year","mm per month","*mm~mo^-1*", +"bio15","bio15","WorldClim_2.1_GFDL-ESM4_ssp245_10m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation seasonality (coeff var)","P season.","year","","", +"bio16","bio16","WorldClim_2.1_GFDL-ESM4_ssp245_10m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest quarter","P of wettest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio17","bio17","WorldClim_2.1_GFDL-ESM4_ssp245_10m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest quarter","P of driest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio18","bio18","WorldClim_2.1_GFDL-ESM4_ssp245_10m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of warmest quarter","P of warmest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio19","bio19","WorldClim_2.1_GFDL-ESM4_ssp245_10m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of coldest quarter","P of coldest qtr","year","mm per quarter","*mm~qtr^-1*", +"precipitation_01","precipitation_01","WorldClim_2.1_GFDL-ESM4_ssp245_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jan","P Jan","january","mm per month","*mm~mo^-1*", +"precipitation_02","precipitation_02","WorldClim_2.1_GFDL-ESM4_ssp245_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Feb","P Feb","february","mm per month","*mm~mo^-1*", +"precipitation_03","precipitation_03","WorldClim_2.1_GFDL-ESM4_ssp245_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Mar","P Mar","march","mm per month","*mm~mo^-1*", +"precipitation_04","precipitation_04","WorldClim_2.1_GFDL-ESM4_ssp245_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Apr","P Apr","april","mm per month","*mm~mo^-1*", +"precipitation_05","precipitation_05","WorldClim_2.1_GFDL-ESM4_ssp245_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation May","P May","may","mm per month","*mm~mo^-1*", +"precipitation_06","precipitation_06","WorldClim_2.1_GFDL-ESM4_ssp245_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jun","P Jun","june","mm per month","*mm~mo^-1*", +"precipitation_07","precipitation_07","WorldClim_2.1_GFDL-ESM4_ssp245_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jul","P Jul","july","mm per month","*mm~mo^-1*", +"precipitation_08","precipitation_08","WorldClim_2.1_GFDL-ESM4_ssp245_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Aug","P Aug","august","mm per month","*mm~mo^-1*", +"precipitation_09","precipitation_09","WorldClim_2.1_GFDL-ESM4_ssp245_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Sep","P Sep","september","mm per month","*mm~mo^-1*", +"precipitation_10","precipitation_10","WorldClim_2.1_GFDL-ESM4_ssp245_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Oct","P Oct","october","mm per month","*mm~mo^-1*", +"precipitation_11","precipitation_11","WorldClim_2.1_GFDL-ESM4_ssp245_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Nov","P Nov","november","mm per month","*mm~mo^-1*", +"precipitation_12","precipitation_12","WorldClim_2.1_GFDL-ESM4_ssp245_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Dec","P Dec","december","mm per month","*mm~mo^-1*", +"temperature_min_01","temperature_min_01","WorldClim_2.1_GFDL-ESM4_ssp245_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jan","min T Jan","january","degrees Celsius","*degree*C*", +"temperature_min_02","temperature_min_02","WorldClim_2.1_GFDL-ESM4_ssp245_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Feb","min T Feb","february","degrees Celsius","*degree*C*", +"temperature_min_03","temperature_min_03","WorldClim_2.1_GFDL-ESM4_ssp245_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Mar","min T Mar","march","degrees Celsius","*degree*C*", +"temperature_min_04","temperature_min_04","WorldClim_2.1_GFDL-ESM4_ssp245_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Apr","min T Apr","april","degrees Celsius","*degree*C*", +"temperature_min_05","temperature_min_05","WorldClim_2.1_GFDL-ESM4_ssp245_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature May","min T May","may","degrees Celsius","*degree*C*", +"temperature_min_06","temperature_min_06","WorldClim_2.1_GFDL-ESM4_ssp245_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jun","min T Jun","june","degrees Celsius","*degree*C*", +"temperature_min_07","temperature_min_07","WorldClim_2.1_GFDL-ESM4_ssp245_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jul","min T Jul","july","degrees Celsius","*degree*C*", +"temperature_min_08","temperature_min_08","WorldClim_2.1_GFDL-ESM4_ssp245_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Aug","min T Aug","august","degrees Celsius","*degree*C*", +"temperature_min_09","temperature_min_09","WorldClim_2.1_GFDL-ESM4_ssp245_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Sep","min T Sep","september","degrees Celsius","*degree*C*", +"temperature_min_10","temperature_min_10","WorldClim_2.1_GFDL-ESM4_ssp245_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Oct","min T Oct","october","degrees Celsius","*degree*C*", +"temperature_min_11","temperature_min_11","WorldClim_2.1_GFDL-ESM4_ssp245_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Nov","min T Nov","november","degrees Celsius","*degree*C*", +"temperature_min_12","temperature_min_12","WorldClim_2.1_GFDL-ESM4_ssp245_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Dec","min T Dec","december","degrees Celsius","*degree*C*", +"temperature_max_01","temperature_max_01","WorldClim_2.1_GFDL-ESM4_ssp245_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jan","max T Jan","january","degrees Celsius","*degree*C*", +"temperature_max_02","temperature_max_02","WorldClim_2.1_GFDL-ESM4_ssp245_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Feb","max T Feb","february","degrees Celsius","*degree*C*", +"temperature_max_03","temperature_max_03","WorldClim_2.1_GFDL-ESM4_ssp245_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Mar","max T Mar","march","degrees Celsius","*degree*C*", +"temperature_max_04","temperature_max_04","WorldClim_2.1_GFDL-ESM4_ssp245_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Apr","max T Apr","april","degrees Celsius","*degree*C*", +"temperature_max_05","temperature_max_05","WorldClim_2.1_GFDL-ESM4_ssp245_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature May","max T May","may","degrees Celsius","*degree*C*", +"temperature_max_06","temperature_max_06","WorldClim_2.1_GFDL-ESM4_ssp245_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jun","max T Jun","june","degrees Celsius","*degree*C*", +"temperature_max_07","temperature_max_07","WorldClim_2.1_GFDL-ESM4_ssp245_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jul","max T Jul","july","degrees Celsius","*degree*C*", +"temperature_max_08","temperature_max_08","WorldClim_2.1_GFDL-ESM4_ssp245_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Aug","max T Aug","august","degrees Celsius","*degree*C*", +"temperature_max_09","temperature_max_09","WorldClim_2.1_GFDL-ESM4_ssp245_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Sep","max T Sep","september","degrees Celsius","*degree*C*", +"temperature_max_10","temperature_max_10","WorldClim_2.1_GFDL-ESM4_ssp245_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Oct","max T Oct","october","degrees Celsius","*degree*C*", +"temperature_max_11","temperature_max_11","WorldClim_2.1_GFDL-ESM4_ssp245_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Nov","max T Nov","november","degrees Celsius","*degree*C*", +"temperature_max_12","temperature_max_12","WorldClim_2.1_GFDL-ESM4_ssp245_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Dec","max T Dec","december","degrees Celsius","*degree*C*", +"bio01","bio01","WorldClim_2.1_GFDL-ESM4_ssp245_5m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual mean temperature","ann. mean T","year","degrees Celsius","*degree*C*", +"bio02","bio02","WorldClim_2.1_GFDL-ESM4_ssp245_5m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean diurnal range","diurn. range","year","degrees Celsius","*degree*C*", +"bio03","bio03","WorldClim_2.1_GFDL-ESM4_ssp245_5m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","isothermality","isothermality","year","","", +"bio04","bio04","WorldClim_2.1_GFDL-ESM4_ssp245_5m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature seasonality","T season.","year","degrees Celsius","*degree*C*", +"bio05","bio05","WorldClim_2.1_GFDL-ESM4_ssp245_5m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature of warmest month","max. T of warmest mo.","year","degrees Celsius","*degree*C*", +"bio06","bio06","WorldClim_2.1_GFDL-ESM4_ssp245_5m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature of coldest month","min. T of coldest mo.","year","degrees Celsius","*degree*C*", +"bio07","bio07","WorldClim_2.1_GFDL-ESM4_ssp245_5m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature annual range (bio05-bio06)","T ann. Range","year","degrees Celsius","*degree*C*", +"bio08","bio08","WorldClim_2.1_GFDL-ESM4_ssp245_5m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of wettest quarter","mean T of wettest qtr","year","degrees Celsius","*degree*C*", +"bio09","bio09","WorldClim_2.1_GFDL-ESM4_ssp245_5m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of driest quarter","mean T of driest qtr","year","degrees Celsius","*degree*C*", +"bio10","bio10","WorldClim_2.1_GFDL-ESM4_ssp245_5m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of warmest quarter","mean T of warmest qtr","year","degrees Celsius","*degree*C*", +"bio11","bio11","WorldClim_2.1_GFDL-ESM4_ssp245_5m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of coldest quarter","mean T of coldest qtr","year","degrees Celsius","*degree*C*", +"bio12","bio12","WorldClim_2.1_GFDL-ESM4_ssp245_5m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual precipitation","ann. P","year","mm per year","*mm~yr^-1*", +"bio13","bio13","WorldClim_2.1_GFDL-ESM4_ssp245_5m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest month","P of wettest mo.","year","mm per month","*mm~mo^-1*", +"bio14","bio14","WorldClim_2.1_GFDL-ESM4_ssp245_5m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest month","P of driest mo.","year","mm per month","*mm~mo^-1*", +"bio15","bio15","WorldClim_2.1_GFDL-ESM4_ssp245_5m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation seasonality (coeff var)","P season.","year","","", +"bio16","bio16","WorldClim_2.1_GFDL-ESM4_ssp245_5m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest quarter","P of wettest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio17","bio17","WorldClim_2.1_GFDL-ESM4_ssp245_5m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest quarter","P of driest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio18","bio18","WorldClim_2.1_GFDL-ESM4_ssp245_5m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of warmest quarter","P of warmest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio19","bio19","WorldClim_2.1_GFDL-ESM4_ssp245_5m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of coldest quarter","P of coldest qtr","year","mm per quarter","*mm~qtr^-1*", +"precipitation_01","precipitation_01","WorldClim_2.1_GFDL-ESM4_ssp245_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jan","P Jan","january","mm per month","*mm~mo^-1*", +"precipitation_02","precipitation_02","WorldClim_2.1_GFDL-ESM4_ssp245_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Feb","P Feb","february","mm per month","*mm~mo^-1*", +"precipitation_03","precipitation_03","WorldClim_2.1_GFDL-ESM4_ssp245_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Mar","P Mar","march","mm per month","*mm~mo^-1*", +"precipitation_04","precipitation_04","WorldClim_2.1_GFDL-ESM4_ssp245_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Apr","P Apr","april","mm per month","*mm~mo^-1*", +"precipitation_05","precipitation_05","WorldClim_2.1_GFDL-ESM4_ssp245_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation May","P May","may","mm per month","*mm~mo^-1*", +"precipitation_06","precipitation_06","WorldClim_2.1_GFDL-ESM4_ssp245_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jun","P Jun","june","mm per month","*mm~mo^-1*", +"precipitation_07","precipitation_07","WorldClim_2.1_GFDL-ESM4_ssp245_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jul","P Jul","july","mm per month","*mm~mo^-1*", +"precipitation_08","precipitation_08","WorldClim_2.1_GFDL-ESM4_ssp245_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Aug","P Aug","august","mm per month","*mm~mo^-1*", +"precipitation_09","precipitation_09","WorldClim_2.1_GFDL-ESM4_ssp245_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Sep","P Sep","september","mm per month","*mm~mo^-1*", +"precipitation_10","precipitation_10","WorldClim_2.1_GFDL-ESM4_ssp245_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Oct","P Oct","october","mm per month","*mm~mo^-1*", +"precipitation_11","precipitation_11","WorldClim_2.1_GFDL-ESM4_ssp245_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Nov","P Nov","november","mm per month","*mm~mo^-1*", +"precipitation_12","precipitation_12","WorldClim_2.1_GFDL-ESM4_ssp245_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Dec","P Dec","december","mm per month","*mm~mo^-1*", +"temperature_min_01","temperature_min_01","WorldClim_2.1_GFDL-ESM4_ssp245_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jan","min T Jan","january","degrees Celsius","*degree*C*", +"temperature_min_02","temperature_min_02","WorldClim_2.1_GFDL-ESM4_ssp245_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Feb","min T Feb","february","degrees Celsius","*degree*C*", +"temperature_min_03","temperature_min_03","WorldClim_2.1_GFDL-ESM4_ssp245_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Mar","min T Mar","march","degrees Celsius","*degree*C*", +"temperature_min_04","temperature_min_04","WorldClim_2.1_GFDL-ESM4_ssp245_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Apr","min T Apr","april","degrees Celsius","*degree*C*", +"temperature_min_05","temperature_min_05","WorldClim_2.1_GFDL-ESM4_ssp245_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature May","min T May","may","degrees Celsius","*degree*C*", +"temperature_min_06","temperature_min_06","WorldClim_2.1_GFDL-ESM4_ssp245_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jun","min T Jun","june","degrees Celsius","*degree*C*", +"temperature_min_07","temperature_min_07","WorldClim_2.1_GFDL-ESM4_ssp245_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jul","min T Jul","july","degrees Celsius","*degree*C*", +"temperature_min_08","temperature_min_08","WorldClim_2.1_GFDL-ESM4_ssp245_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Aug","min T Aug","august","degrees Celsius","*degree*C*", +"temperature_min_09","temperature_min_09","WorldClim_2.1_GFDL-ESM4_ssp245_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Sep","min T Sep","september","degrees Celsius","*degree*C*", +"temperature_min_10","temperature_min_10","WorldClim_2.1_GFDL-ESM4_ssp245_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Oct","min T Oct","october","degrees Celsius","*degree*C*", +"temperature_min_11","temperature_min_11","WorldClim_2.1_GFDL-ESM4_ssp245_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Nov","min T Nov","november","degrees Celsius","*degree*C*", +"temperature_min_12","temperature_min_12","WorldClim_2.1_GFDL-ESM4_ssp245_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Dec","min T Dec","december","degrees Celsius","*degree*C*", +"temperature_max_01","temperature_max_01","WorldClim_2.1_GFDL-ESM4_ssp245_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jan","max T Jan","january","degrees Celsius","*degree*C*", +"temperature_max_02","temperature_max_02","WorldClim_2.1_GFDL-ESM4_ssp245_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Feb","max T Feb","february","degrees Celsius","*degree*C*", +"temperature_max_03","temperature_max_03","WorldClim_2.1_GFDL-ESM4_ssp245_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Mar","max T Mar","march","degrees Celsius","*degree*C*", +"temperature_max_04","temperature_max_04","WorldClim_2.1_GFDL-ESM4_ssp245_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Apr","max T Apr","april","degrees Celsius","*degree*C*", +"temperature_max_05","temperature_max_05","WorldClim_2.1_GFDL-ESM4_ssp245_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature May","max T May","may","degrees Celsius","*degree*C*", +"temperature_max_06","temperature_max_06","WorldClim_2.1_GFDL-ESM4_ssp245_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jun","max T Jun","june","degrees Celsius","*degree*C*", +"temperature_max_07","temperature_max_07","WorldClim_2.1_GFDL-ESM4_ssp245_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jul","max T Jul","july","degrees Celsius","*degree*C*", +"temperature_max_08","temperature_max_08","WorldClim_2.1_GFDL-ESM4_ssp245_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Aug","max T Aug","august","degrees Celsius","*degree*C*", +"temperature_max_09","temperature_max_09","WorldClim_2.1_GFDL-ESM4_ssp245_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Sep","max T Sep","september","degrees Celsius","*degree*C*", +"temperature_max_10","temperature_max_10","WorldClim_2.1_GFDL-ESM4_ssp245_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Oct","max T Oct","october","degrees Celsius","*degree*C*", +"temperature_max_11","temperature_max_11","WorldClim_2.1_GFDL-ESM4_ssp245_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Nov","max T Nov","november","degrees Celsius","*degree*C*", +"temperature_max_12","temperature_max_12","WorldClim_2.1_GFDL-ESM4_ssp245_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Dec","max T Dec","december","degrees Celsius","*degree*C*", +"bio01","bio01","WorldClim_2.1_GFDL-ESM4_ssp370_10m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual mean temperature","ann. mean T","year","degrees Celsius","*degree*C*", +"bio02","bio02","WorldClim_2.1_GFDL-ESM4_ssp370_10m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean diurnal range","diurn. range","year","degrees Celsius","*degree*C*", +"bio03","bio03","WorldClim_2.1_GFDL-ESM4_ssp370_10m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","isothermality","isothermality","year","","", +"bio04","bio04","WorldClim_2.1_GFDL-ESM4_ssp370_10m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature seasonality","T season.","year","degrees Celsius","*degree*C*", +"bio05","bio05","WorldClim_2.1_GFDL-ESM4_ssp370_10m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature of warmest month","max. T of warmest mo.","year","degrees Celsius","*degree*C*", +"bio06","bio06","WorldClim_2.1_GFDL-ESM4_ssp370_10m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature of coldest month","min. T of coldest mo.","year","degrees Celsius","*degree*C*", +"bio07","bio07","WorldClim_2.1_GFDL-ESM4_ssp370_10m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature annual range (bio05-bio06)","T ann. Range","year","degrees Celsius","*degree*C*", +"bio08","bio08","WorldClim_2.1_GFDL-ESM4_ssp370_10m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of wettest quarter","mean T of wettest qtr","year","degrees Celsius","*degree*C*", +"bio09","bio09","WorldClim_2.1_GFDL-ESM4_ssp370_10m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of driest quarter","mean T of driest qtr","year","degrees Celsius","*degree*C*", +"bio10","bio10","WorldClim_2.1_GFDL-ESM4_ssp370_10m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of warmest quarter","mean T of warmest qtr","year","degrees Celsius","*degree*C*", +"bio11","bio11","WorldClim_2.1_GFDL-ESM4_ssp370_10m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of coldest quarter","mean T of coldest qtr","year","degrees Celsius","*degree*C*", +"bio12","bio12","WorldClim_2.1_GFDL-ESM4_ssp370_10m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual precipitation","ann. P","year","mm per year","*mm~yr^-1*", +"bio13","bio13","WorldClim_2.1_GFDL-ESM4_ssp370_10m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest month","P of wettest mo.","year","mm per month","*mm~mo^-1*", +"bio14","bio14","WorldClim_2.1_GFDL-ESM4_ssp370_10m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest month","P of driest mo.","year","mm per month","*mm~mo^-1*", +"bio15","bio15","WorldClim_2.1_GFDL-ESM4_ssp370_10m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation seasonality (coeff var)","P season.","year","","", +"bio16","bio16","WorldClim_2.1_GFDL-ESM4_ssp370_10m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest quarter","P of wettest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio17","bio17","WorldClim_2.1_GFDL-ESM4_ssp370_10m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest quarter","P of driest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio18","bio18","WorldClim_2.1_GFDL-ESM4_ssp370_10m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of warmest quarter","P of warmest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio19","bio19","WorldClim_2.1_GFDL-ESM4_ssp370_10m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of coldest quarter","P of coldest qtr","year","mm per quarter","*mm~qtr^-1*", +"precipitation_01","precipitation_01","WorldClim_2.1_GFDL-ESM4_ssp370_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jan","P Jan","january","mm per month","*mm~mo^-1*", +"precipitation_02","precipitation_02","WorldClim_2.1_GFDL-ESM4_ssp370_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Feb","P Feb","february","mm per month","*mm~mo^-1*", +"precipitation_03","precipitation_03","WorldClim_2.1_GFDL-ESM4_ssp370_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Mar","P Mar","march","mm per month","*mm~mo^-1*", +"precipitation_04","precipitation_04","WorldClim_2.1_GFDL-ESM4_ssp370_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Apr","P Apr","april","mm per month","*mm~mo^-1*", +"precipitation_05","precipitation_05","WorldClim_2.1_GFDL-ESM4_ssp370_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation May","P May","may","mm per month","*mm~mo^-1*", +"precipitation_06","precipitation_06","WorldClim_2.1_GFDL-ESM4_ssp370_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jun","P Jun","june","mm per month","*mm~mo^-1*", +"precipitation_07","precipitation_07","WorldClim_2.1_GFDL-ESM4_ssp370_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jul","P Jul","july","mm per month","*mm~mo^-1*", +"precipitation_08","precipitation_08","WorldClim_2.1_GFDL-ESM4_ssp370_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Aug","P Aug","august","mm per month","*mm~mo^-1*", +"precipitation_09","precipitation_09","WorldClim_2.1_GFDL-ESM4_ssp370_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Sep","P Sep","september","mm per month","*mm~mo^-1*", +"precipitation_10","precipitation_10","WorldClim_2.1_GFDL-ESM4_ssp370_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Oct","P Oct","october","mm per month","*mm~mo^-1*", +"precipitation_11","precipitation_11","WorldClim_2.1_GFDL-ESM4_ssp370_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Nov","P Nov","november","mm per month","*mm~mo^-1*", +"precipitation_12","precipitation_12","WorldClim_2.1_GFDL-ESM4_ssp370_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Dec","P Dec","december","mm per month","*mm~mo^-1*", +"temperature_min_01","temperature_min_01","WorldClim_2.1_GFDL-ESM4_ssp370_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jan","min T Jan","january","degrees Celsius","*degree*C*", +"temperature_min_02","temperature_min_02","WorldClim_2.1_GFDL-ESM4_ssp370_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Feb","min T Feb","february","degrees Celsius","*degree*C*", +"temperature_min_03","temperature_min_03","WorldClim_2.1_GFDL-ESM4_ssp370_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Mar","min T Mar","march","degrees Celsius","*degree*C*", +"temperature_min_04","temperature_min_04","WorldClim_2.1_GFDL-ESM4_ssp370_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Apr","min T Apr","april","degrees Celsius","*degree*C*", +"temperature_min_05","temperature_min_05","WorldClim_2.1_GFDL-ESM4_ssp370_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature May","min T May","may","degrees Celsius","*degree*C*", +"temperature_min_06","temperature_min_06","WorldClim_2.1_GFDL-ESM4_ssp370_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jun","min T Jun","june","degrees Celsius","*degree*C*", +"temperature_min_07","temperature_min_07","WorldClim_2.1_GFDL-ESM4_ssp370_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jul","min T Jul","july","degrees Celsius","*degree*C*", +"temperature_min_08","temperature_min_08","WorldClim_2.1_GFDL-ESM4_ssp370_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Aug","min T Aug","august","degrees Celsius","*degree*C*", +"temperature_min_09","temperature_min_09","WorldClim_2.1_GFDL-ESM4_ssp370_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Sep","min T Sep","september","degrees Celsius","*degree*C*", +"temperature_min_10","temperature_min_10","WorldClim_2.1_GFDL-ESM4_ssp370_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Oct","min T Oct","october","degrees Celsius","*degree*C*", +"temperature_min_11","temperature_min_11","WorldClim_2.1_GFDL-ESM4_ssp370_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Nov","min T Nov","november","degrees Celsius","*degree*C*", +"temperature_min_12","temperature_min_12","WorldClim_2.1_GFDL-ESM4_ssp370_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Dec","min T Dec","december","degrees Celsius","*degree*C*", +"temperature_max_01","temperature_max_01","WorldClim_2.1_GFDL-ESM4_ssp370_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jan","max T Jan","january","degrees Celsius","*degree*C*", +"temperature_max_02","temperature_max_02","WorldClim_2.1_GFDL-ESM4_ssp370_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Feb","max T Feb","february","degrees Celsius","*degree*C*", +"temperature_max_03","temperature_max_03","WorldClim_2.1_GFDL-ESM4_ssp370_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Mar","max T Mar","march","degrees Celsius","*degree*C*", +"temperature_max_04","temperature_max_04","WorldClim_2.1_GFDL-ESM4_ssp370_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Apr","max T Apr","april","degrees Celsius","*degree*C*", +"temperature_max_05","temperature_max_05","WorldClim_2.1_GFDL-ESM4_ssp370_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature May","max T May","may","degrees Celsius","*degree*C*", +"temperature_max_06","temperature_max_06","WorldClim_2.1_GFDL-ESM4_ssp370_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jun","max T Jun","june","degrees Celsius","*degree*C*", +"temperature_max_07","temperature_max_07","WorldClim_2.1_GFDL-ESM4_ssp370_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jul","max T Jul","july","degrees Celsius","*degree*C*", +"temperature_max_08","temperature_max_08","WorldClim_2.1_GFDL-ESM4_ssp370_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Aug","max T Aug","august","degrees Celsius","*degree*C*", +"temperature_max_09","temperature_max_09","WorldClim_2.1_GFDL-ESM4_ssp370_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Sep","max T Sep","september","degrees Celsius","*degree*C*", +"temperature_max_10","temperature_max_10","WorldClim_2.1_GFDL-ESM4_ssp370_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Oct","max T Oct","october","degrees Celsius","*degree*C*", +"temperature_max_11","temperature_max_11","WorldClim_2.1_GFDL-ESM4_ssp370_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Nov","max T Nov","november","degrees Celsius","*degree*C*", +"temperature_max_12","temperature_max_12","WorldClim_2.1_GFDL-ESM4_ssp370_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Dec","max T Dec","december","degrees Celsius","*degree*C*", +"bio01","bio01","WorldClim_2.1_GFDL-ESM4_ssp370_5m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual mean temperature","ann. mean T","year","degrees Celsius","*degree*C*", +"bio02","bio02","WorldClim_2.1_GFDL-ESM4_ssp370_5m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean diurnal range","diurn. range","year","degrees Celsius","*degree*C*", +"bio03","bio03","WorldClim_2.1_GFDL-ESM4_ssp370_5m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","isothermality","isothermality","year","","", +"bio04","bio04","WorldClim_2.1_GFDL-ESM4_ssp370_5m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature seasonality","T season.","year","degrees Celsius","*degree*C*", +"bio05","bio05","WorldClim_2.1_GFDL-ESM4_ssp370_5m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature of warmest month","max. T of warmest mo.","year","degrees Celsius","*degree*C*", +"bio06","bio06","WorldClim_2.1_GFDL-ESM4_ssp370_5m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature of coldest month","min. T of coldest mo.","year","degrees Celsius","*degree*C*", +"bio07","bio07","WorldClim_2.1_GFDL-ESM4_ssp370_5m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature annual range (bio05-bio06)","T ann. Range","year","degrees Celsius","*degree*C*", +"bio08","bio08","WorldClim_2.1_GFDL-ESM4_ssp370_5m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of wettest quarter","mean T of wettest qtr","year","degrees Celsius","*degree*C*", +"bio09","bio09","WorldClim_2.1_GFDL-ESM4_ssp370_5m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of driest quarter","mean T of driest qtr","year","degrees Celsius","*degree*C*", +"bio10","bio10","WorldClim_2.1_GFDL-ESM4_ssp370_5m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of warmest quarter","mean T of warmest qtr","year","degrees Celsius","*degree*C*", +"bio11","bio11","WorldClim_2.1_GFDL-ESM4_ssp370_5m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of coldest quarter","mean T of coldest qtr","year","degrees Celsius","*degree*C*", +"bio12","bio12","WorldClim_2.1_GFDL-ESM4_ssp370_5m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual precipitation","ann. P","year","mm per year","*mm~yr^-1*", +"bio13","bio13","WorldClim_2.1_GFDL-ESM4_ssp370_5m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest month","P of wettest mo.","year","mm per month","*mm~mo^-1*", +"bio14","bio14","WorldClim_2.1_GFDL-ESM4_ssp370_5m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest month","P of driest mo.","year","mm per month","*mm~mo^-1*", +"bio15","bio15","WorldClim_2.1_GFDL-ESM4_ssp370_5m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation seasonality (coeff var)","P season.","year","","", +"bio16","bio16","WorldClim_2.1_GFDL-ESM4_ssp370_5m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest quarter","P of wettest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio17","bio17","WorldClim_2.1_GFDL-ESM4_ssp370_5m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest quarter","P of driest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio18","bio18","WorldClim_2.1_GFDL-ESM4_ssp370_5m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of warmest quarter","P of warmest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio19","bio19","WorldClim_2.1_GFDL-ESM4_ssp370_5m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of coldest quarter","P of coldest qtr","year","mm per quarter","*mm~qtr^-1*", +"precipitation_01","precipitation_01","WorldClim_2.1_GFDL-ESM4_ssp370_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jan","P Jan","january","mm per month","*mm~mo^-1*", +"precipitation_02","precipitation_02","WorldClim_2.1_GFDL-ESM4_ssp370_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Feb","P Feb","february","mm per month","*mm~mo^-1*", +"precipitation_03","precipitation_03","WorldClim_2.1_GFDL-ESM4_ssp370_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Mar","P Mar","march","mm per month","*mm~mo^-1*", +"precipitation_04","precipitation_04","WorldClim_2.1_GFDL-ESM4_ssp370_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Apr","P Apr","april","mm per month","*mm~mo^-1*", +"precipitation_05","precipitation_05","WorldClim_2.1_GFDL-ESM4_ssp370_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation May","P May","may","mm per month","*mm~mo^-1*", +"precipitation_06","precipitation_06","WorldClim_2.1_GFDL-ESM4_ssp370_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jun","P Jun","june","mm per month","*mm~mo^-1*", +"precipitation_07","precipitation_07","WorldClim_2.1_GFDL-ESM4_ssp370_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jul","P Jul","july","mm per month","*mm~mo^-1*", +"precipitation_08","precipitation_08","WorldClim_2.1_GFDL-ESM4_ssp370_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Aug","P Aug","august","mm per month","*mm~mo^-1*", +"precipitation_09","precipitation_09","WorldClim_2.1_GFDL-ESM4_ssp370_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Sep","P Sep","september","mm per month","*mm~mo^-1*", +"precipitation_10","precipitation_10","WorldClim_2.1_GFDL-ESM4_ssp370_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Oct","P Oct","october","mm per month","*mm~mo^-1*", +"precipitation_11","precipitation_11","WorldClim_2.1_GFDL-ESM4_ssp370_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Nov","P Nov","november","mm per month","*mm~mo^-1*", +"precipitation_12","precipitation_12","WorldClim_2.1_GFDL-ESM4_ssp370_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Dec","P Dec","december","mm per month","*mm~mo^-1*", +"temperature_min_01","temperature_min_01","WorldClim_2.1_GFDL-ESM4_ssp370_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jan","min T Jan","january","degrees Celsius","*degree*C*", +"temperature_min_02","temperature_min_02","WorldClim_2.1_GFDL-ESM4_ssp370_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Feb","min T Feb","february","degrees Celsius","*degree*C*", +"temperature_min_03","temperature_min_03","WorldClim_2.1_GFDL-ESM4_ssp370_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Mar","min T Mar","march","degrees Celsius","*degree*C*", +"temperature_min_04","temperature_min_04","WorldClim_2.1_GFDL-ESM4_ssp370_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Apr","min T Apr","april","degrees Celsius","*degree*C*", +"temperature_min_05","temperature_min_05","WorldClim_2.1_GFDL-ESM4_ssp370_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature May","min T May","may","degrees Celsius","*degree*C*", +"temperature_min_06","temperature_min_06","WorldClim_2.1_GFDL-ESM4_ssp370_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jun","min T Jun","june","degrees Celsius","*degree*C*", +"temperature_min_07","temperature_min_07","WorldClim_2.1_GFDL-ESM4_ssp370_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jul","min T Jul","july","degrees Celsius","*degree*C*", +"temperature_min_08","temperature_min_08","WorldClim_2.1_GFDL-ESM4_ssp370_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Aug","min T Aug","august","degrees Celsius","*degree*C*", +"temperature_min_09","temperature_min_09","WorldClim_2.1_GFDL-ESM4_ssp370_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Sep","min T Sep","september","degrees Celsius","*degree*C*", +"temperature_min_10","temperature_min_10","WorldClim_2.1_GFDL-ESM4_ssp370_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Oct","min T Oct","october","degrees Celsius","*degree*C*", +"temperature_min_11","temperature_min_11","WorldClim_2.1_GFDL-ESM4_ssp370_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Nov","min T Nov","november","degrees Celsius","*degree*C*", +"temperature_min_12","temperature_min_12","WorldClim_2.1_GFDL-ESM4_ssp370_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Dec","min T Dec","december","degrees Celsius","*degree*C*", +"temperature_max_01","temperature_max_01","WorldClim_2.1_GFDL-ESM4_ssp370_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jan","max T Jan","january","degrees Celsius","*degree*C*", +"temperature_max_02","temperature_max_02","WorldClim_2.1_GFDL-ESM4_ssp370_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Feb","max T Feb","february","degrees Celsius","*degree*C*", +"temperature_max_03","temperature_max_03","WorldClim_2.1_GFDL-ESM4_ssp370_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Mar","max T Mar","march","degrees Celsius","*degree*C*", +"temperature_max_04","temperature_max_04","WorldClim_2.1_GFDL-ESM4_ssp370_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Apr","max T Apr","april","degrees Celsius","*degree*C*", +"temperature_max_05","temperature_max_05","WorldClim_2.1_GFDL-ESM4_ssp370_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature May","max T May","may","degrees Celsius","*degree*C*", +"temperature_max_06","temperature_max_06","WorldClim_2.1_GFDL-ESM4_ssp370_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jun","max T Jun","june","degrees Celsius","*degree*C*", +"temperature_max_07","temperature_max_07","WorldClim_2.1_GFDL-ESM4_ssp370_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jul","max T Jul","july","degrees Celsius","*degree*C*", +"temperature_max_08","temperature_max_08","WorldClim_2.1_GFDL-ESM4_ssp370_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Aug","max T Aug","august","degrees Celsius","*degree*C*", +"temperature_max_09","temperature_max_09","WorldClim_2.1_GFDL-ESM4_ssp370_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Sep","max T Sep","september","degrees Celsius","*degree*C*", +"temperature_max_10","temperature_max_10","WorldClim_2.1_GFDL-ESM4_ssp370_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Oct","max T Oct","october","degrees Celsius","*degree*C*", +"temperature_max_11","temperature_max_11","WorldClim_2.1_GFDL-ESM4_ssp370_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Nov","max T Nov","november","degrees Celsius","*degree*C*", +"temperature_max_12","temperature_max_12","WorldClim_2.1_GFDL-ESM4_ssp370_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Dec","max T Dec","december","degrees Celsius","*degree*C*", +"bio01","bio01","WorldClim_2.1_GFDL-ESM4_ssp585_10m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual mean temperature","ann. mean T","year","degrees Celsius","*degree*C*", +"bio02","bio02","WorldClim_2.1_GFDL-ESM4_ssp585_10m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean diurnal range","diurn. range","year","degrees Celsius","*degree*C*", +"bio03","bio03","WorldClim_2.1_GFDL-ESM4_ssp585_10m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","isothermality","isothermality","year","","", +"bio04","bio04","WorldClim_2.1_GFDL-ESM4_ssp585_10m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature seasonality","T season.","year","degrees Celsius","*degree*C*", +"bio05","bio05","WorldClim_2.1_GFDL-ESM4_ssp585_10m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature of warmest month","max. T of warmest mo.","year","degrees Celsius","*degree*C*", +"bio06","bio06","WorldClim_2.1_GFDL-ESM4_ssp585_10m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature of coldest month","min. T of coldest mo.","year","degrees Celsius","*degree*C*", +"bio07","bio07","WorldClim_2.1_GFDL-ESM4_ssp585_10m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature annual range (bio05-bio06)","T ann. Range","year","degrees Celsius","*degree*C*", +"bio08","bio08","WorldClim_2.1_GFDL-ESM4_ssp585_10m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of wettest quarter","mean T of wettest qtr","year","degrees Celsius","*degree*C*", +"bio09","bio09","WorldClim_2.1_GFDL-ESM4_ssp585_10m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of driest quarter","mean T of driest qtr","year","degrees Celsius","*degree*C*", +"bio10","bio10","WorldClim_2.1_GFDL-ESM4_ssp585_10m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of warmest quarter","mean T of warmest qtr","year","degrees Celsius","*degree*C*", +"bio11","bio11","WorldClim_2.1_GFDL-ESM4_ssp585_10m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of coldest quarter","mean T of coldest qtr","year","degrees Celsius","*degree*C*", +"bio12","bio12","WorldClim_2.1_GFDL-ESM4_ssp585_10m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual precipitation","ann. P","year","mm per year","*mm~yr^-1*", +"bio13","bio13","WorldClim_2.1_GFDL-ESM4_ssp585_10m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest month","P of wettest mo.","year","mm per month","*mm~mo^-1*", +"bio14","bio14","WorldClim_2.1_GFDL-ESM4_ssp585_10m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest month","P of driest mo.","year","mm per month","*mm~mo^-1*", +"bio15","bio15","WorldClim_2.1_GFDL-ESM4_ssp585_10m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation seasonality (coeff var)","P season.","year","","", +"bio16","bio16","WorldClim_2.1_GFDL-ESM4_ssp585_10m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest quarter","P of wettest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio17","bio17","WorldClim_2.1_GFDL-ESM4_ssp585_10m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest quarter","P of driest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio18","bio18","WorldClim_2.1_GFDL-ESM4_ssp585_10m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of warmest quarter","P of warmest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio19","bio19","WorldClim_2.1_GFDL-ESM4_ssp585_10m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of coldest quarter","P of coldest qtr","year","mm per quarter","*mm~qtr^-1*", +"precipitation_01","precipitation_01","WorldClim_2.1_GFDL-ESM4_ssp585_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jan","P Jan","january","mm per month","*mm~mo^-1*", +"precipitation_02","precipitation_02","WorldClim_2.1_GFDL-ESM4_ssp585_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Feb","P Feb","february","mm per month","*mm~mo^-1*", +"precipitation_03","precipitation_03","WorldClim_2.1_GFDL-ESM4_ssp585_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Mar","P Mar","march","mm per month","*mm~mo^-1*", +"precipitation_04","precipitation_04","WorldClim_2.1_GFDL-ESM4_ssp585_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Apr","P Apr","april","mm per month","*mm~mo^-1*", +"precipitation_05","precipitation_05","WorldClim_2.1_GFDL-ESM4_ssp585_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation May","P May","may","mm per month","*mm~mo^-1*", +"precipitation_06","precipitation_06","WorldClim_2.1_GFDL-ESM4_ssp585_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jun","P Jun","june","mm per month","*mm~mo^-1*", +"precipitation_07","precipitation_07","WorldClim_2.1_GFDL-ESM4_ssp585_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jul","P Jul","july","mm per month","*mm~mo^-1*", +"precipitation_08","precipitation_08","WorldClim_2.1_GFDL-ESM4_ssp585_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Aug","P Aug","august","mm per month","*mm~mo^-1*", +"precipitation_09","precipitation_09","WorldClim_2.1_GFDL-ESM4_ssp585_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Sep","P Sep","september","mm per month","*mm~mo^-1*", +"precipitation_10","precipitation_10","WorldClim_2.1_GFDL-ESM4_ssp585_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Oct","P Oct","october","mm per month","*mm~mo^-1*", +"precipitation_11","precipitation_11","WorldClim_2.1_GFDL-ESM4_ssp585_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Nov","P Nov","november","mm per month","*mm~mo^-1*", +"precipitation_12","precipitation_12","WorldClim_2.1_GFDL-ESM4_ssp585_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Dec","P Dec","december","mm per month","*mm~mo^-1*", +"temperature_min_01","temperature_min_01","WorldClim_2.1_GFDL-ESM4_ssp585_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jan","min T Jan","january","degrees Celsius","*degree*C*", +"temperature_min_02","temperature_min_02","WorldClim_2.1_GFDL-ESM4_ssp585_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Feb","min T Feb","february","degrees Celsius","*degree*C*", +"temperature_min_03","temperature_min_03","WorldClim_2.1_GFDL-ESM4_ssp585_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Mar","min T Mar","march","degrees Celsius","*degree*C*", +"temperature_min_04","temperature_min_04","WorldClim_2.1_GFDL-ESM4_ssp585_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Apr","min T Apr","april","degrees Celsius","*degree*C*", +"temperature_min_05","temperature_min_05","WorldClim_2.1_GFDL-ESM4_ssp585_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature May","min T May","may","degrees Celsius","*degree*C*", +"temperature_min_06","temperature_min_06","WorldClim_2.1_GFDL-ESM4_ssp585_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jun","min T Jun","june","degrees Celsius","*degree*C*", +"temperature_min_07","temperature_min_07","WorldClim_2.1_GFDL-ESM4_ssp585_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jul","min T Jul","july","degrees Celsius","*degree*C*", +"temperature_min_08","temperature_min_08","WorldClim_2.1_GFDL-ESM4_ssp585_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Aug","min T Aug","august","degrees Celsius","*degree*C*", +"temperature_min_09","temperature_min_09","WorldClim_2.1_GFDL-ESM4_ssp585_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Sep","min T Sep","september","degrees Celsius","*degree*C*", +"temperature_min_10","temperature_min_10","WorldClim_2.1_GFDL-ESM4_ssp585_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Oct","min T Oct","october","degrees Celsius","*degree*C*", +"temperature_min_11","temperature_min_11","WorldClim_2.1_GFDL-ESM4_ssp585_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Nov","min T Nov","november","degrees Celsius","*degree*C*", +"temperature_min_12","temperature_min_12","WorldClim_2.1_GFDL-ESM4_ssp585_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Dec","min T Dec","december","degrees Celsius","*degree*C*", +"temperature_max_01","temperature_max_01","WorldClim_2.1_GFDL-ESM4_ssp585_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jan","max T Jan","january","degrees Celsius","*degree*C*", +"temperature_max_02","temperature_max_02","WorldClim_2.1_GFDL-ESM4_ssp585_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Feb","max T Feb","february","degrees Celsius","*degree*C*", +"temperature_max_03","temperature_max_03","WorldClim_2.1_GFDL-ESM4_ssp585_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Mar","max T Mar","march","degrees Celsius","*degree*C*", +"temperature_max_04","temperature_max_04","WorldClim_2.1_GFDL-ESM4_ssp585_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Apr","max T Apr","april","degrees Celsius","*degree*C*", +"temperature_max_05","temperature_max_05","WorldClim_2.1_GFDL-ESM4_ssp585_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature May","max T May","may","degrees Celsius","*degree*C*", +"temperature_max_06","temperature_max_06","WorldClim_2.1_GFDL-ESM4_ssp585_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jun","max T Jun","june","degrees Celsius","*degree*C*", +"temperature_max_07","temperature_max_07","WorldClim_2.1_GFDL-ESM4_ssp585_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jul","max T Jul","july","degrees Celsius","*degree*C*", +"temperature_max_08","temperature_max_08","WorldClim_2.1_GFDL-ESM4_ssp585_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Aug","max T Aug","august","degrees Celsius","*degree*C*", +"temperature_max_09","temperature_max_09","WorldClim_2.1_GFDL-ESM4_ssp585_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Sep","max T Sep","september","degrees Celsius","*degree*C*", +"temperature_max_10","temperature_max_10","WorldClim_2.1_GFDL-ESM4_ssp585_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Oct","max T Oct","october","degrees Celsius","*degree*C*", +"temperature_max_11","temperature_max_11","WorldClim_2.1_GFDL-ESM4_ssp585_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Nov","max T Nov","november","degrees Celsius","*degree*C*", +"temperature_max_12","temperature_max_12","WorldClim_2.1_GFDL-ESM4_ssp585_10m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Dec","max T Dec","december","degrees Celsius","*degree*C*", +"bio01","bio01","WorldClim_2.1_GFDL-ESM4_ssp585_5m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual mean temperature","ann. mean T","year","degrees Celsius","*degree*C*", +"bio02","bio02","WorldClim_2.1_GFDL-ESM4_ssp585_5m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean diurnal range","diurn. range","year","degrees Celsius","*degree*C*", +"bio03","bio03","WorldClim_2.1_GFDL-ESM4_ssp585_5m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","isothermality","isothermality","year","","", +"bio04","bio04","WorldClim_2.1_GFDL-ESM4_ssp585_5m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature seasonality","T season.","year","degrees Celsius","*degree*C*", +"bio05","bio05","WorldClim_2.1_GFDL-ESM4_ssp585_5m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature of warmest month","max. T of warmest mo.","year","degrees Celsius","*degree*C*", +"bio06","bio06","WorldClim_2.1_GFDL-ESM4_ssp585_5m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature of coldest month","min. T of coldest mo.","year","degrees Celsius","*degree*C*", +"bio07","bio07","WorldClim_2.1_GFDL-ESM4_ssp585_5m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature annual range (bio05-bio06)","T ann. Range","year","degrees Celsius","*degree*C*", +"bio08","bio08","WorldClim_2.1_GFDL-ESM4_ssp585_5m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of wettest quarter","mean T of wettest qtr","year","degrees Celsius","*degree*C*", +"bio09","bio09","WorldClim_2.1_GFDL-ESM4_ssp585_5m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of driest quarter","mean T of driest qtr","year","degrees Celsius","*degree*C*", +"bio10","bio10","WorldClim_2.1_GFDL-ESM4_ssp585_5m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of warmest quarter","mean T of warmest qtr","year","degrees Celsius","*degree*C*", +"bio11","bio11","WorldClim_2.1_GFDL-ESM4_ssp585_5m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of coldest quarter","mean T of coldest qtr","year","degrees Celsius","*degree*C*", +"bio12","bio12","WorldClim_2.1_GFDL-ESM4_ssp585_5m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual precipitation","ann. P","year","mm per year","*mm~yr^-1*", +"bio13","bio13","WorldClim_2.1_GFDL-ESM4_ssp585_5m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest month","P of wettest mo.","year","mm per month","*mm~mo^-1*", +"bio14","bio14","WorldClim_2.1_GFDL-ESM4_ssp585_5m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest month","P of driest mo.","year","mm per month","*mm~mo^-1*", +"bio15","bio15","WorldClim_2.1_GFDL-ESM4_ssp585_5m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation seasonality (coeff var)","P season.","year","","", +"bio16","bio16","WorldClim_2.1_GFDL-ESM4_ssp585_5m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest quarter","P of wettest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio17","bio17","WorldClim_2.1_GFDL-ESM4_ssp585_5m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest quarter","P of driest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio18","bio18","WorldClim_2.1_GFDL-ESM4_ssp585_5m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of warmest quarter","P of warmest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio19","bio19","WorldClim_2.1_GFDL-ESM4_ssp585_5m",FALSE,"WorldClim_2.1_GFDL-ESM4_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of coldest quarter","P of coldest qtr","year","mm per quarter","*mm~qtr^-1*", +"precipitation_01","precipitation_01","WorldClim_2.1_GFDL-ESM4_ssp585_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jan","P Jan","january","mm per month","*mm~mo^-1*", +"precipitation_02","precipitation_02","WorldClim_2.1_GFDL-ESM4_ssp585_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Feb","P Feb","february","mm per month","*mm~mo^-1*", +"precipitation_03","precipitation_03","WorldClim_2.1_GFDL-ESM4_ssp585_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Mar","P Mar","march","mm per month","*mm~mo^-1*", +"precipitation_04","precipitation_04","WorldClim_2.1_GFDL-ESM4_ssp585_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Apr","P Apr","april","mm per month","*mm~mo^-1*", +"precipitation_05","precipitation_05","WorldClim_2.1_GFDL-ESM4_ssp585_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation May","P May","may","mm per month","*mm~mo^-1*", +"precipitation_06","precipitation_06","WorldClim_2.1_GFDL-ESM4_ssp585_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jun","P Jun","june","mm per month","*mm~mo^-1*", +"precipitation_07","precipitation_07","WorldClim_2.1_GFDL-ESM4_ssp585_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jul","P Jul","july","mm per month","*mm~mo^-1*", +"precipitation_08","precipitation_08","WorldClim_2.1_GFDL-ESM4_ssp585_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Aug","P Aug","august","mm per month","*mm~mo^-1*", +"precipitation_09","precipitation_09","WorldClim_2.1_GFDL-ESM4_ssp585_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Sep","P Sep","september","mm per month","*mm~mo^-1*", +"precipitation_10","precipitation_10","WorldClim_2.1_GFDL-ESM4_ssp585_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Oct","P Oct","october","mm per month","*mm~mo^-1*", +"precipitation_11","precipitation_11","WorldClim_2.1_GFDL-ESM4_ssp585_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Nov","P Nov","november","mm per month","*mm~mo^-1*", +"precipitation_12","precipitation_12","WorldClim_2.1_GFDL-ESM4_ssp585_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Dec","P Dec","december","mm per month","*mm~mo^-1*", +"temperature_min_01","temperature_min_01","WorldClim_2.1_GFDL-ESM4_ssp585_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jan","min T Jan","january","degrees Celsius","*degree*C*", +"temperature_min_02","temperature_min_02","WorldClim_2.1_GFDL-ESM4_ssp585_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Feb","min T Feb","february","degrees Celsius","*degree*C*", +"temperature_min_03","temperature_min_03","WorldClim_2.1_GFDL-ESM4_ssp585_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Mar","min T Mar","march","degrees Celsius","*degree*C*", +"temperature_min_04","temperature_min_04","WorldClim_2.1_GFDL-ESM4_ssp585_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Apr","min T Apr","april","degrees Celsius","*degree*C*", +"temperature_min_05","temperature_min_05","WorldClim_2.1_GFDL-ESM4_ssp585_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature May","min T May","may","degrees Celsius","*degree*C*", +"temperature_min_06","temperature_min_06","WorldClim_2.1_GFDL-ESM4_ssp585_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jun","min T Jun","june","degrees Celsius","*degree*C*", +"temperature_min_07","temperature_min_07","WorldClim_2.1_GFDL-ESM4_ssp585_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jul","min T Jul","july","degrees Celsius","*degree*C*", +"temperature_min_08","temperature_min_08","WorldClim_2.1_GFDL-ESM4_ssp585_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Aug","min T Aug","august","degrees Celsius","*degree*C*", +"temperature_min_09","temperature_min_09","WorldClim_2.1_GFDL-ESM4_ssp585_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Sep","min T Sep","september","degrees Celsius","*degree*C*", +"temperature_min_10","temperature_min_10","WorldClim_2.1_GFDL-ESM4_ssp585_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Oct","min T Oct","october","degrees Celsius","*degree*C*", +"temperature_min_11","temperature_min_11","WorldClim_2.1_GFDL-ESM4_ssp585_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Nov","min T Nov","november","degrees Celsius","*degree*C*", +"temperature_min_12","temperature_min_12","WorldClim_2.1_GFDL-ESM4_ssp585_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Dec","min T Dec","december","degrees Celsius","*degree*C*", +"temperature_max_01","temperature_max_01","WorldClim_2.1_GFDL-ESM4_ssp585_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jan","max T Jan","january","degrees Celsius","*degree*C*", +"temperature_max_02","temperature_max_02","WorldClim_2.1_GFDL-ESM4_ssp585_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Feb","max T Feb","february","degrees Celsius","*degree*C*", +"temperature_max_03","temperature_max_03","WorldClim_2.1_GFDL-ESM4_ssp585_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Mar","max T Mar","march","degrees Celsius","*degree*C*", +"temperature_max_04","temperature_max_04","WorldClim_2.1_GFDL-ESM4_ssp585_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Apr","max T Apr","april","degrees Celsius","*degree*C*", +"temperature_max_05","temperature_max_05","WorldClim_2.1_GFDL-ESM4_ssp585_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature May","max T May","may","degrees Celsius","*degree*C*", +"temperature_max_06","temperature_max_06","WorldClim_2.1_GFDL-ESM4_ssp585_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jun","max T Jun","june","degrees Celsius","*degree*C*", +"temperature_max_07","temperature_max_07","WorldClim_2.1_GFDL-ESM4_ssp585_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jul","max T Jul","july","degrees Celsius","*degree*C*", +"temperature_max_08","temperature_max_08","WorldClim_2.1_GFDL-ESM4_ssp585_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Aug","max T Aug","august","degrees Celsius","*degree*C*", +"temperature_max_09","temperature_max_09","WorldClim_2.1_GFDL-ESM4_ssp585_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Sep","max T Sep","september","degrees Celsius","*degree*C*", +"temperature_max_10","temperature_max_10","WorldClim_2.1_GFDL-ESM4_ssp585_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Oct","max T Oct","october","degrees Celsius","*degree*C*", +"temperature_max_11","temperature_max_11","WorldClim_2.1_GFDL-ESM4_ssp585_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Nov","max T Nov","november","degrees Celsius","*degree*C*", +"temperature_max_12","temperature_max_12","WorldClim_2.1_GFDL-ESM4_ssp585_5m",TRUE,"WorldClim_2.1_GFDL-ESM4_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Dec","max T Dec","december","degrees Celsius","*degree*C*", +"bio01","bio01","WorldClim_2.1_GISS-E2-1-G_ssp126_10m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual mean temperature","ann. mean T","year","degrees Celsius","*degree*C*", +"bio02","bio02","WorldClim_2.1_GISS-E2-1-G_ssp126_10m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean diurnal range","diurn. range","year","degrees Celsius","*degree*C*", +"bio03","bio03","WorldClim_2.1_GISS-E2-1-G_ssp126_10m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","isothermality","isothermality","year","","", +"bio04","bio04","WorldClim_2.1_GISS-E2-1-G_ssp126_10m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature seasonality","T season.","year","degrees Celsius","*degree*C*", +"bio05","bio05","WorldClim_2.1_GISS-E2-1-G_ssp126_10m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature of warmest month","max. T of warmest mo.","year","degrees Celsius","*degree*C*", +"bio06","bio06","WorldClim_2.1_GISS-E2-1-G_ssp126_10m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature of coldest month","min. T of coldest mo.","year","degrees Celsius","*degree*C*", +"bio07","bio07","WorldClim_2.1_GISS-E2-1-G_ssp126_10m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature annual range (bio05-bio06)","T ann. Range","year","degrees Celsius","*degree*C*", +"bio08","bio08","WorldClim_2.1_GISS-E2-1-G_ssp126_10m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of wettest quarter","mean T of wettest qtr","year","degrees Celsius","*degree*C*", +"bio09","bio09","WorldClim_2.1_GISS-E2-1-G_ssp126_10m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of driest quarter","mean T of driest qtr","year","degrees Celsius","*degree*C*", +"bio10","bio10","WorldClim_2.1_GISS-E2-1-G_ssp126_10m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of warmest quarter","mean T of warmest qtr","year","degrees Celsius","*degree*C*", +"bio11","bio11","WorldClim_2.1_GISS-E2-1-G_ssp126_10m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of coldest quarter","mean T of coldest qtr","year","degrees Celsius","*degree*C*", +"bio12","bio12","WorldClim_2.1_GISS-E2-1-G_ssp126_10m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual precipitation","ann. P","year","mm per year","*mm~yr^-1*", +"bio13","bio13","WorldClim_2.1_GISS-E2-1-G_ssp126_10m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest month","P of wettest mo.","year","mm per month","*mm~mo^-1*", +"bio14","bio14","WorldClim_2.1_GISS-E2-1-G_ssp126_10m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest month","P of driest mo.","year","mm per month","*mm~mo^-1*", +"bio15","bio15","WorldClim_2.1_GISS-E2-1-G_ssp126_10m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation seasonality (coeff var)","P season.","year","","", +"bio16","bio16","WorldClim_2.1_GISS-E2-1-G_ssp126_10m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest quarter","P of wettest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio17","bio17","WorldClim_2.1_GISS-E2-1-G_ssp126_10m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest quarter","P of driest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio18","bio18","WorldClim_2.1_GISS-E2-1-G_ssp126_10m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of warmest quarter","P of warmest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio19","bio19","WorldClim_2.1_GISS-E2-1-G_ssp126_10m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of coldest quarter","P of coldest qtr","year","mm per quarter","*mm~qtr^-1*", +"precipitation_01","precipitation_01","WorldClim_2.1_GISS-E2-1-G_ssp126_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jan","P Jan","january","mm per month","*mm~mo^-1*", +"precipitation_02","precipitation_02","WorldClim_2.1_GISS-E2-1-G_ssp126_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Feb","P Feb","february","mm per month","*mm~mo^-1*", +"precipitation_03","precipitation_03","WorldClim_2.1_GISS-E2-1-G_ssp126_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Mar","P Mar","march","mm per month","*mm~mo^-1*", +"precipitation_04","precipitation_04","WorldClim_2.1_GISS-E2-1-G_ssp126_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Apr","P Apr","april","mm per month","*mm~mo^-1*", +"precipitation_05","precipitation_05","WorldClim_2.1_GISS-E2-1-G_ssp126_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation May","P May","may","mm per month","*mm~mo^-1*", +"precipitation_06","precipitation_06","WorldClim_2.1_GISS-E2-1-G_ssp126_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jun","P Jun","june","mm per month","*mm~mo^-1*", +"precipitation_07","precipitation_07","WorldClim_2.1_GISS-E2-1-G_ssp126_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jul","P Jul","july","mm per month","*mm~mo^-1*", +"precipitation_08","precipitation_08","WorldClim_2.1_GISS-E2-1-G_ssp126_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Aug","P Aug","august","mm per month","*mm~mo^-1*", +"precipitation_09","precipitation_09","WorldClim_2.1_GISS-E2-1-G_ssp126_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Sep","P Sep","september","mm per month","*mm~mo^-1*", +"precipitation_10","precipitation_10","WorldClim_2.1_GISS-E2-1-G_ssp126_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Oct","P Oct","october","mm per month","*mm~mo^-1*", +"precipitation_11","precipitation_11","WorldClim_2.1_GISS-E2-1-G_ssp126_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Nov","P Nov","november","mm per month","*mm~mo^-1*", +"precipitation_12","precipitation_12","WorldClim_2.1_GISS-E2-1-G_ssp126_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Dec","P Dec","december","mm per month","*mm~mo^-1*", +"temperature_min_01","temperature_min_01","WorldClim_2.1_GISS-E2-1-G_ssp126_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jan","min T Jan","january","degrees Celsius","*degree*C*", +"temperature_min_02","temperature_min_02","WorldClim_2.1_GISS-E2-1-G_ssp126_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Feb","min T Feb","february","degrees Celsius","*degree*C*", +"temperature_min_03","temperature_min_03","WorldClim_2.1_GISS-E2-1-G_ssp126_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Mar","min T Mar","march","degrees Celsius","*degree*C*", +"temperature_min_04","temperature_min_04","WorldClim_2.1_GISS-E2-1-G_ssp126_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Apr","min T Apr","april","degrees Celsius","*degree*C*", +"temperature_min_05","temperature_min_05","WorldClim_2.1_GISS-E2-1-G_ssp126_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature May","min T May","may","degrees Celsius","*degree*C*", +"temperature_min_06","temperature_min_06","WorldClim_2.1_GISS-E2-1-G_ssp126_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jun","min T Jun","june","degrees Celsius","*degree*C*", +"temperature_min_07","temperature_min_07","WorldClim_2.1_GISS-E2-1-G_ssp126_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jul","min T Jul","july","degrees Celsius","*degree*C*", +"temperature_min_08","temperature_min_08","WorldClim_2.1_GISS-E2-1-G_ssp126_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Aug","min T Aug","august","degrees Celsius","*degree*C*", +"temperature_min_09","temperature_min_09","WorldClim_2.1_GISS-E2-1-G_ssp126_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Sep","min T Sep","september","degrees Celsius","*degree*C*", +"temperature_min_10","temperature_min_10","WorldClim_2.1_GISS-E2-1-G_ssp126_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Oct","min T Oct","october","degrees Celsius","*degree*C*", +"temperature_min_11","temperature_min_11","WorldClim_2.1_GISS-E2-1-G_ssp126_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Nov","min T Nov","november","degrees Celsius","*degree*C*", +"temperature_min_12","temperature_min_12","WorldClim_2.1_GISS-E2-1-G_ssp126_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Dec","min T Dec","december","degrees Celsius","*degree*C*", +"temperature_max_01","temperature_max_01","WorldClim_2.1_GISS-E2-1-G_ssp126_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jan","max T Jan","january","degrees Celsius","*degree*C*", +"temperature_max_02","temperature_max_02","WorldClim_2.1_GISS-E2-1-G_ssp126_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Feb","max T Feb","february","degrees Celsius","*degree*C*", +"temperature_max_03","temperature_max_03","WorldClim_2.1_GISS-E2-1-G_ssp126_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Mar","max T Mar","march","degrees Celsius","*degree*C*", +"temperature_max_04","temperature_max_04","WorldClim_2.1_GISS-E2-1-G_ssp126_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Apr","max T Apr","april","degrees Celsius","*degree*C*", +"temperature_max_05","temperature_max_05","WorldClim_2.1_GISS-E2-1-G_ssp126_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature May","max T May","may","degrees Celsius","*degree*C*", +"temperature_max_06","temperature_max_06","WorldClim_2.1_GISS-E2-1-G_ssp126_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jun","max T Jun","june","degrees Celsius","*degree*C*", +"temperature_max_07","temperature_max_07","WorldClim_2.1_GISS-E2-1-G_ssp126_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jul","max T Jul","july","degrees Celsius","*degree*C*", +"temperature_max_08","temperature_max_08","WorldClim_2.1_GISS-E2-1-G_ssp126_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Aug","max T Aug","august","degrees Celsius","*degree*C*", +"temperature_max_09","temperature_max_09","WorldClim_2.1_GISS-E2-1-G_ssp126_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Sep","max T Sep","september","degrees Celsius","*degree*C*", +"temperature_max_10","temperature_max_10","WorldClim_2.1_GISS-E2-1-G_ssp126_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Oct","max T Oct","october","degrees Celsius","*degree*C*", +"temperature_max_11","temperature_max_11","WorldClim_2.1_GISS-E2-1-G_ssp126_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Nov","max T Nov","november","degrees Celsius","*degree*C*", +"temperature_max_12","temperature_max_12","WorldClim_2.1_GISS-E2-1-G_ssp126_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Dec","max T Dec","december","degrees Celsius","*degree*C*", +"bio01","bio01","WorldClim_2.1_GISS-E2-1-G_ssp126_5m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual mean temperature","ann. mean T","year","degrees Celsius","*degree*C*", +"bio02","bio02","WorldClim_2.1_GISS-E2-1-G_ssp126_5m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean diurnal range","diurn. range","year","degrees Celsius","*degree*C*", +"bio03","bio03","WorldClim_2.1_GISS-E2-1-G_ssp126_5m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","isothermality","isothermality","year","","", +"bio04","bio04","WorldClim_2.1_GISS-E2-1-G_ssp126_5m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature seasonality","T season.","year","degrees Celsius","*degree*C*", +"bio05","bio05","WorldClim_2.1_GISS-E2-1-G_ssp126_5m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature of warmest month","max. T of warmest mo.","year","degrees Celsius","*degree*C*", +"bio06","bio06","WorldClim_2.1_GISS-E2-1-G_ssp126_5m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature of coldest month","min. T of coldest mo.","year","degrees Celsius","*degree*C*", +"bio07","bio07","WorldClim_2.1_GISS-E2-1-G_ssp126_5m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature annual range (bio05-bio06)","T ann. Range","year","degrees Celsius","*degree*C*", +"bio08","bio08","WorldClim_2.1_GISS-E2-1-G_ssp126_5m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of wettest quarter","mean T of wettest qtr","year","degrees Celsius","*degree*C*", +"bio09","bio09","WorldClim_2.1_GISS-E2-1-G_ssp126_5m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of driest quarter","mean T of driest qtr","year","degrees Celsius","*degree*C*", +"bio10","bio10","WorldClim_2.1_GISS-E2-1-G_ssp126_5m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of warmest quarter","mean T of warmest qtr","year","degrees Celsius","*degree*C*", +"bio11","bio11","WorldClim_2.1_GISS-E2-1-G_ssp126_5m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of coldest quarter","mean T of coldest qtr","year","degrees Celsius","*degree*C*", +"bio12","bio12","WorldClim_2.1_GISS-E2-1-G_ssp126_5m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual precipitation","ann. P","year","mm per year","*mm~yr^-1*", +"bio13","bio13","WorldClim_2.1_GISS-E2-1-G_ssp126_5m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest month","P of wettest mo.","year","mm per month","*mm~mo^-1*", +"bio14","bio14","WorldClim_2.1_GISS-E2-1-G_ssp126_5m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest month","P of driest mo.","year","mm per month","*mm~mo^-1*", +"bio15","bio15","WorldClim_2.1_GISS-E2-1-G_ssp126_5m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation seasonality (coeff var)","P season.","year","","", +"bio16","bio16","WorldClim_2.1_GISS-E2-1-G_ssp126_5m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest quarter","P of wettest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio17","bio17","WorldClim_2.1_GISS-E2-1-G_ssp126_5m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest quarter","P of driest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio18","bio18","WorldClim_2.1_GISS-E2-1-G_ssp126_5m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of warmest quarter","P of warmest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio19","bio19","WorldClim_2.1_GISS-E2-1-G_ssp126_5m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of coldest quarter","P of coldest qtr","year","mm per quarter","*mm~qtr^-1*", +"precipitation_01","precipitation_01","WorldClim_2.1_GISS-E2-1-G_ssp126_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jan","P Jan","january","mm per month","*mm~mo^-1*", +"precipitation_02","precipitation_02","WorldClim_2.1_GISS-E2-1-G_ssp126_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Feb","P Feb","february","mm per month","*mm~mo^-1*", +"precipitation_03","precipitation_03","WorldClim_2.1_GISS-E2-1-G_ssp126_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Mar","P Mar","march","mm per month","*mm~mo^-1*", +"precipitation_04","precipitation_04","WorldClim_2.1_GISS-E2-1-G_ssp126_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Apr","P Apr","april","mm per month","*mm~mo^-1*", +"precipitation_05","precipitation_05","WorldClim_2.1_GISS-E2-1-G_ssp126_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation May","P May","may","mm per month","*mm~mo^-1*", +"precipitation_06","precipitation_06","WorldClim_2.1_GISS-E2-1-G_ssp126_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jun","P Jun","june","mm per month","*mm~mo^-1*", +"precipitation_07","precipitation_07","WorldClim_2.1_GISS-E2-1-G_ssp126_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jul","P Jul","july","mm per month","*mm~mo^-1*", +"precipitation_08","precipitation_08","WorldClim_2.1_GISS-E2-1-G_ssp126_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Aug","P Aug","august","mm per month","*mm~mo^-1*", +"precipitation_09","precipitation_09","WorldClim_2.1_GISS-E2-1-G_ssp126_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Sep","P Sep","september","mm per month","*mm~mo^-1*", +"precipitation_10","precipitation_10","WorldClim_2.1_GISS-E2-1-G_ssp126_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Oct","P Oct","october","mm per month","*mm~mo^-1*", +"precipitation_11","precipitation_11","WorldClim_2.1_GISS-E2-1-G_ssp126_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Nov","P Nov","november","mm per month","*mm~mo^-1*", +"precipitation_12","precipitation_12","WorldClim_2.1_GISS-E2-1-G_ssp126_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Dec","P Dec","december","mm per month","*mm~mo^-1*", +"temperature_min_01","temperature_min_01","WorldClim_2.1_GISS-E2-1-G_ssp126_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jan","min T Jan","january","degrees Celsius","*degree*C*", +"temperature_min_02","temperature_min_02","WorldClim_2.1_GISS-E2-1-G_ssp126_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Feb","min T Feb","february","degrees Celsius","*degree*C*", +"temperature_min_03","temperature_min_03","WorldClim_2.1_GISS-E2-1-G_ssp126_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Mar","min T Mar","march","degrees Celsius","*degree*C*", +"temperature_min_04","temperature_min_04","WorldClim_2.1_GISS-E2-1-G_ssp126_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Apr","min T Apr","april","degrees Celsius","*degree*C*", +"temperature_min_05","temperature_min_05","WorldClim_2.1_GISS-E2-1-G_ssp126_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature May","min T May","may","degrees Celsius","*degree*C*", +"temperature_min_06","temperature_min_06","WorldClim_2.1_GISS-E2-1-G_ssp126_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jun","min T Jun","june","degrees Celsius","*degree*C*", +"temperature_min_07","temperature_min_07","WorldClim_2.1_GISS-E2-1-G_ssp126_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jul","min T Jul","july","degrees Celsius","*degree*C*", +"temperature_min_08","temperature_min_08","WorldClim_2.1_GISS-E2-1-G_ssp126_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Aug","min T Aug","august","degrees Celsius","*degree*C*", +"temperature_min_09","temperature_min_09","WorldClim_2.1_GISS-E2-1-G_ssp126_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Sep","min T Sep","september","degrees Celsius","*degree*C*", +"temperature_min_10","temperature_min_10","WorldClim_2.1_GISS-E2-1-G_ssp126_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Oct","min T Oct","october","degrees Celsius","*degree*C*", +"temperature_min_11","temperature_min_11","WorldClim_2.1_GISS-E2-1-G_ssp126_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Nov","min T Nov","november","degrees Celsius","*degree*C*", +"temperature_min_12","temperature_min_12","WorldClim_2.1_GISS-E2-1-G_ssp126_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Dec","min T Dec","december","degrees Celsius","*degree*C*", +"temperature_max_01","temperature_max_01","WorldClim_2.1_GISS-E2-1-G_ssp126_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jan","max T Jan","january","degrees Celsius","*degree*C*", +"temperature_max_02","temperature_max_02","WorldClim_2.1_GISS-E2-1-G_ssp126_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Feb","max T Feb","february","degrees Celsius","*degree*C*", +"temperature_max_03","temperature_max_03","WorldClim_2.1_GISS-E2-1-G_ssp126_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Mar","max T Mar","march","degrees Celsius","*degree*C*", +"temperature_max_04","temperature_max_04","WorldClim_2.1_GISS-E2-1-G_ssp126_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Apr","max T Apr","april","degrees Celsius","*degree*C*", +"temperature_max_05","temperature_max_05","WorldClim_2.1_GISS-E2-1-G_ssp126_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature May","max T May","may","degrees Celsius","*degree*C*", +"temperature_max_06","temperature_max_06","WorldClim_2.1_GISS-E2-1-G_ssp126_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jun","max T Jun","june","degrees Celsius","*degree*C*", +"temperature_max_07","temperature_max_07","WorldClim_2.1_GISS-E2-1-G_ssp126_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jul","max T Jul","july","degrees Celsius","*degree*C*", +"temperature_max_08","temperature_max_08","WorldClim_2.1_GISS-E2-1-G_ssp126_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Aug","max T Aug","august","degrees Celsius","*degree*C*", +"temperature_max_09","temperature_max_09","WorldClim_2.1_GISS-E2-1-G_ssp126_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Sep","max T Sep","september","degrees Celsius","*degree*C*", +"temperature_max_10","temperature_max_10","WorldClim_2.1_GISS-E2-1-G_ssp126_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Oct","max T Oct","october","degrees Celsius","*degree*C*", +"temperature_max_11","temperature_max_11","WorldClim_2.1_GISS-E2-1-G_ssp126_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Nov","max T Nov","november","degrees Celsius","*degree*C*", +"temperature_max_12","temperature_max_12","WorldClim_2.1_GISS-E2-1-G_ssp126_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Dec","max T Dec","december","degrees Celsius","*degree*C*", +"bio01","bio01","WorldClim_2.1_GISS-E2-1-G_ssp245_10m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual mean temperature","ann. mean T","year","degrees Celsius","*degree*C*", +"bio02","bio02","WorldClim_2.1_GISS-E2-1-G_ssp245_10m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean diurnal range","diurn. range","year","degrees Celsius","*degree*C*", +"bio03","bio03","WorldClim_2.1_GISS-E2-1-G_ssp245_10m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","isothermality","isothermality","year","","", +"bio04","bio04","WorldClim_2.1_GISS-E2-1-G_ssp245_10m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature seasonality","T season.","year","degrees Celsius","*degree*C*", +"bio05","bio05","WorldClim_2.1_GISS-E2-1-G_ssp245_10m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature of warmest month","max. T of warmest mo.","year","degrees Celsius","*degree*C*", +"bio06","bio06","WorldClim_2.1_GISS-E2-1-G_ssp245_10m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature of coldest month","min. T of coldest mo.","year","degrees Celsius","*degree*C*", +"bio07","bio07","WorldClim_2.1_GISS-E2-1-G_ssp245_10m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature annual range (bio05-bio06)","T ann. Range","year","degrees Celsius","*degree*C*", +"bio08","bio08","WorldClim_2.1_GISS-E2-1-G_ssp245_10m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of wettest quarter","mean T of wettest qtr","year","degrees Celsius","*degree*C*", +"bio09","bio09","WorldClim_2.1_GISS-E2-1-G_ssp245_10m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of driest quarter","mean T of driest qtr","year","degrees Celsius","*degree*C*", +"bio10","bio10","WorldClim_2.1_GISS-E2-1-G_ssp245_10m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of warmest quarter","mean T of warmest qtr","year","degrees Celsius","*degree*C*", +"bio11","bio11","WorldClim_2.1_GISS-E2-1-G_ssp245_10m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of coldest quarter","mean T of coldest qtr","year","degrees Celsius","*degree*C*", +"bio12","bio12","WorldClim_2.1_GISS-E2-1-G_ssp245_10m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual precipitation","ann. P","year","mm per year","*mm~yr^-1*", +"bio13","bio13","WorldClim_2.1_GISS-E2-1-G_ssp245_10m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest month","P of wettest mo.","year","mm per month","*mm~mo^-1*", +"bio14","bio14","WorldClim_2.1_GISS-E2-1-G_ssp245_10m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest month","P of driest mo.","year","mm per month","*mm~mo^-1*", +"bio15","bio15","WorldClim_2.1_GISS-E2-1-G_ssp245_10m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation seasonality (coeff var)","P season.","year","","", +"bio16","bio16","WorldClim_2.1_GISS-E2-1-G_ssp245_10m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest quarter","P of wettest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio17","bio17","WorldClim_2.1_GISS-E2-1-G_ssp245_10m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest quarter","P of driest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio18","bio18","WorldClim_2.1_GISS-E2-1-G_ssp245_10m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of warmest quarter","P of warmest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio19","bio19","WorldClim_2.1_GISS-E2-1-G_ssp245_10m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of coldest quarter","P of coldest qtr","year","mm per quarter","*mm~qtr^-1*", +"precipitation_01","precipitation_01","WorldClim_2.1_GISS-E2-1-G_ssp245_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jan","P Jan","january","mm per month","*mm~mo^-1*", +"precipitation_02","precipitation_02","WorldClim_2.1_GISS-E2-1-G_ssp245_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Feb","P Feb","february","mm per month","*mm~mo^-1*", +"precipitation_03","precipitation_03","WorldClim_2.1_GISS-E2-1-G_ssp245_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Mar","P Mar","march","mm per month","*mm~mo^-1*", +"precipitation_04","precipitation_04","WorldClim_2.1_GISS-E2-1-G_ssp245_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Apr","P Apr","april","mm per month","*mm~mo^-1*", +"precipitation_05","precipitation_05","WorldClim_2.1_GISS-E2-1-G_ssp245_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation May","P May","may","mm per month","*mm~mo^-1*", +"precipitation_06","precipitation_06","WorldClim_2.1_GISS-E2-1-G_ssp245_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jun","P Jun","june","mm per month","*mm~mo^-1*", +"precipitation_07","precipitation_07","WorldClim_2.1_GISS-E2-1-G_ssp245_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jul","P Jul","july","mm per month","*mm~mo^-1*", +"precipitation_08","precipitation_08","WorldClim_2.1_GISS-E2-1-G_ssp245_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Aug","P Aug","august","mm per month","*mm~mo^-1*", +"precipitation_09","precipitation_09","WorldClim_2.1_GISS-E2-1-G_ssp245_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Sep","P Sep","september","mm per month","*mm~mo^-1*", +"precipitation_10","precipitation_10","WorldClim_2.1_GISS-E2-1-G_ssp245_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Oct","P Oct","october","mm per month","*mm~mo^-1*", +"precipitation_11","precipitation_11","WorldClim_2.1_GISS-E2-1-G_ssp245_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Nov","P Nov","november","mm per month","*mm~mo^-1*", +"precipitation_12","precipitation_12","WorldClim_2.1_GISS-E2-1-G_ssp245_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Dec","P Dec","december","mm per month","*mm~mo^-1*", +"temperature_min_01","temperature_min_01","WorldClim_2.1_GISS-E2-1-G_ssp245_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jan","min T Jan","january","degrees Celsius","*degree*C*", +"temperature_min_02","temperature_min_02","WorldClim_2.1_GISS-E2-1-G_ssp245_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Feb","min T Feb","february","degrees Celsius","*degree*C*", +"temperature_min_03","temperature_min_03","WorldClim_2.1_GISS-E2-1-G_ssp245_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Mar","min T Mar","march","degrees Celsius","*degree*C*", +"temperature_min_04","temperature_min_04","WorldClim_2.1_GISS-E2-1-G_ssp245_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Apr","min T Apr","april","degrees Celsius","*degree*C*", +"temperature_min_05","temperature_min_05","WorldClim_2.1_GISS-E2-1-G_ssp245_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature May","min T May","may","degrees Celsius","*degree*C*", +"temperature_min_06","temperature_min_06","WorldClim_2.1_GISS-E2-1-G_ssp245_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jun","min T Jun","june","degrees Celsius","*degree*C*", +"temperature_min_07","temperature_min_07","WorldClim_2.1_GISS-E2-1-G_ssp245_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jul","min T Jul","july","degrees Celsius","*degree*C*", +"temperature_min_08","temperature_min_08","WorldClim_2.1_GISS-E2-1-G_ssp245_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Aug","min T Aug","august","degrees Celsius","*degree*C*", +"temperature_min_09","temperature_min_09","WorldClim_2.1_GISS-E2-1-G_ssp245_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Sep","min T Sep","september","degrees Celsius","*degree*C*", +"temperature_min_10","temperature_min_10","WorldClim_2.1_GISS-E2-1-G_ssp245_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Oct","min T Oct","october","degrees Celsius","*degree*C*", +"temperature_min_11","temperature_min_11","WorldClim_2.1_GISS-E2-1-G_ssp245_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Nov","min T Nov","november","degrees Celsius","*degree*C*", +"temperature_min_12","temperature_min_12","WorldClim_2.1_GISS-E2-1-G_ssp245_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Dec","min T Dec","december","degrees Celsius","*degree*C*", +"temperature_max_01","temperature_max_01","WorldClim_2.1_GISS-E2-1-G_ssp245_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jan","max T Jan","january","degrees Celsius","*degree*C*", +"temperature_max_02","temperature_max_02","WorldClim_2.1_GISS-E2-1-G_ssp245_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Feb","max T Feb","february","degrees Celsius","*degree*C*", +"temperature_max_03","temperature_max_03","WorldClim_2.1_GISS-E2-1-G_ssp245_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Mar","max T Mar","march","degrees Celsius","*degree*C*", +"temperature_max_04","temperature_max_04","WorldClim_2.1_GISS-E2-1-G_ssp245_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Apr","max T Apr","april","degrees Celsius","*degree*C*", +"temperature_max_05","temperature_max_05","WorldClim_2.1_GISS-E2-1-G_ssp245_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature May","max T May","may","degrees Celsius","*degree*C*", +"temperature_max_06","temperature_max_06","WorldClim_2.1_GISS-E2-1-G_ssp245_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jun","max T Jun","june","degrees Celsius","*degree*C*", +"temperature_max_07","temperature_max_07","WorldClim_2.1_GISS-E2-1-G_ssp245_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jul","max T Jul","july","degrees Celsius","*degree*C*", +"temperature_max_08","temperature_max_08","WorldClim_2.1_GISS-E2-1-G_ssp245_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Aug","max T Aug","august","degrees Celsius","*degree*C*", +"temperature_max_09","temperature_max_09","WorldClim_2.1_GISS-E2-1-G_ssp245_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Sep","max T Sep","september","degrees Celsius","*degree*C*", +"temperature_max_10","temperature_max_10","WorldClim_2.1_GISS-E2-1-G_ssp245_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Oct","max T Oct","october","degrees Celsius","*degree*C*", +"temperature_max_11","temperature_max_11","WorldClim_2.1_GISS-E2-1-G_ssp245_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Nov","max T Nov","november","degrees Celsius","*degree*C*", +"temperature_max_12","temperature_max_12","WorldClim_2.1_GISS-E2-1-G_ssp245_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Dec","max T Dec","december","degrees Celsius","*degree*C*", +"bio01","bio01","WorldClim_2.1_GISS-E2-1-G_ssp245_5m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual mean temperature","ann. mean T","year","degrees Celsius","*degree*C*", +"bio02","bio02","WorldClim_2.1_GISS-E2-1-G_ssp245_5m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean diurnal range","diurn. range","year","degrees Celsius","*degree*C*", +"bio03","bio03","WorldClim_2.1_GISS-E2-1-G_ssp245_5m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","isothermality","isothermality","year","","", +"bio04","bio04","WorldClim_2.1_GISS-E2-1-G_ssp245_5m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature seasonality","T season.","year","degrees Celsius","*degree*C*", +"bio05","bio05","WorldClim_2.1_GISS-E2-1-G_ssp245_5m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature of warmest month","max. T of warmest mo.","year","degrees Celsius","*degree*C*", +"bio06","bio06","WorldClim_2.1_GISS-E2-1-G_ssp245_5m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature of coldest month","min. T of coldest mo.","year","degrees Celsius","*degree*C*", +"bio07","bio07","WorldClim_2.1_GISS-E2-1-G_ssp245_5m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature annual range (bio05-bio06)","T ann. Range","year","degrees Celsius","*degree*C*", +"bio08","bio08","WorldClim_2.1_GISS-E2-1-G_ssp245_5m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of wettest quarter","mean T of wettest qtr","year","degrees Celsius","*degree*C*", +"bio09","bio09","WorldClim_2.1_GISS-E2-1-G_ssp245_5m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of driest quarter","mean T of driest qtr","year","degrees Celsius","*degree*C*", +"bio10","bio10","WorldClim_2.1_GISS-E2-1-G_ssp245_5m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of warmest quarter","mean T of warmest qtr","year","degrees Celsius","*degree*C*", +"bio11","bio11","WorldClim_2.1_GISS-E2-1-G_ssp245_5m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of coldest quarter","mean T of coldest qtr","year","degrees Celsius","*degree*C*", +"bio12","bio12","WorldClim_2.1_GISS-E2-1-G_ssp245_5m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual precipitation","ann. P","year","mm per year","*mm~yr^-1*", +"bio13","bio13","WorldClim_2.1_GISS-E2-1-G_ssp245_5m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest month","P of wettest mo.","year","mm per month","*mm~mo^-1*", +"bio14","bio14","WorldClim_2.1_GISS-E2-1-G_ssp245_5m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest month","P of driest mo.","year","mm per month","*mm~mo^-1*", +"bio15","bio15","WorldClim_2.1_GISS-E2-1-G_ssp245_5m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation seasonality (coeff var)","P season.","year","","", +"bio16","bio16","WorldClim_2.1_GISS-E2-1-G_ssp245_5m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest quarter","P of wettest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio17","bio17","WorldClim_2.1_GISS-E2-1-G_ssp245_5m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest quarter","P of driest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio18","bio18","WorldClim_2.1_GISS-E2-1-G_ssp245_5m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of warmest quarter","P of warmest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio19","bio19","WorldClim_2.1_GISS-E2-1-G_ssp245_5m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of coldest quarter","P of coldest qtr","year","mm per quarter","*mm~qtr^-1*", +"precipitation_01","precipitation_01","WorldClim_2.1_GISS-E2-1-G_ssp245_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jan","P Jan","january","mm per month","*mm~mo^-1*", +"precipitation_02","precipitation_02","WorldClim_2.1_GISS-E2-1-G_ssp245_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Feb","P Feb","february","mm per month","*mm~mo^-1*", +"precipitation_03","precipitation_03","WorldClim_2.1_GISS-E2-1-G_ssp245_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Mar","P Mar","march","mm per month","*mm~mo^-1*", +"precipitation_04","precipitation_04","WorldClim_2.1_GISS-E2-1-G_ssp245_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Apr","P Apr","april","mm per month","*mm~mo^-1*", +"precipitation_05","precipitation_05","WorldClim_2.1_GISS-E2-1-G_ssp245_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation May","P May","may","mm per month","*mm~mo^-1*", +"precipitation_06","precipitation_06","WorldClim_2.1_GISS-E2-1-G_ssp245_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jun","P Jun","june","mm per month","*mm~mo^-1*", +"precipitation_07","precipitation_07","WorldClim_2.1_GISS-E2-1-G_ssp245_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jul","P Jul","july","mm per month","*mm~mo^-1*", +"precipitation_08","precipitation_08","WorldClim_2.1_GISS-E2-1-G_ssp245_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Aug","P Aug","august","mm per month","*mm~mo^-1*", +"precipitation_09","precipitation_09","WorldClim_2.1_GISS-E2-1-G_ssp245_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Sep","P Sep","september","mm per month","*mm~mo^-1*", +"precipitation_10","precipitation_10","WorldClim_2.1_GISS-E2-1-G_ssp245_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Oct","P Oct","october","mm per month","*mm~mo^-1*", +"precipitation_11","precipitation_11","WorldClim_2.1_GISS-E2-1-G_ssp245_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Nov","P Nov","november","mm per month","*mm~mo^-1*", +"precipitation_12","precipitation_12","WorldClim_2.1_GISS-E2-1-G_ssp245_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Dec","P Dec","december","mm per month","*mm~mo^-1*", +"temperature_min_01","temperature_min_01","WorldClim_2.1_GISS-E2-1-G_ssp245_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jan","min T Jan","january","degrees Celsius","*degree*C*", +"temperature_min_02","temperature_min_02","WorldClim_2.1_GISS-E2-1-G_ssp245_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Feb","min T Feb","february","degrees Celsius","*degree*C*", +"temperature_min_03","temperature_min_03","WorldClim_2.1_GISS-E2-1-G_ssp245_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Mar","min T Mar","march","degrees Celsius","*degree*C*", +"temperature_min_04","temperature_min_04","WorldClim_2.1_GISS-E2-1-G_ssp245_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Apr","min T Apr","april","degrees Celsius","*degree*C*", +"temperature_min_05","temperature_min_05","WorldClim_2.1_GISS-E2-1-G_ssp245_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature May","min T May","may","degrees Celsius","*degree*C*", +"temperature_min_06","temperature_min_06","WorldClim_2.1_GISS-E2-1-G_ssp245_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jun","min T Jun","june","degrees Celsius","*degree*C*", +"temperature_min_07","temperature_min_07","WorldClim_2.1_GISS-E2-1-G_ssp245_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jul","min T Jul","july","degrees Celsius","*degree*C*", +"temperature_min_08","temperature_min_08","WorldClim_2.1_GISS-E2-1-G_ssp245_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Aug","min T Aug","august","degrees Celsius","*degree*C*", +"temperature_min_09","temperature_min_09","WorldClim_2.1_GISS-E2-1-G_ssp245_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Sep","min T Sep","september","degrees Celsius","*degree*C*", +"temperature_min_10","temperature_min_10","WorldClim_2.1_GISS-E2-1-G_ssp245_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Oct","min T Oct","october","degrees Celsius","*degree*C*", +"temperature_min_11","temperature_min_11","WorldClim_2.1_GISS-E2-1-G_ssp245_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Nov","min T Nov","november","degrees Celsius","*degree*C*", +"temperature_min_12","temperature_min_12","WorldClim_2.1_GISS-E2-1-G_ssp245_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Dec","min T Dec","december","degrees Celsius","*degree*C*", +"temperature_max_01","temperature_max_01","WorldClim_2.1_GISS-E2-1-G_ssp245_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jan","max T Jan","january","degrees Celsius","*degree*C*", +"temperature_max_02","temperature_max_02","WorldClim_2.1_GISS-E2-1-G_ssp245_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Feb","max T Feb","february","degrees Celsius","*degree*C*", +"temperature_max_03","temperature_max_03","WorldClim_2.1_GISS-E2-1-G_ssp245_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Mar","max T Mar","march","degrees Celsius","*degree*C*", +"temperature_max_04","temperature_max_04","WorldClim_2.1_GISS-E2-1-G_ssp245_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Apr","max T Apr","april","degrees Celsius","*degree*C*", +"temperature_max_05","temperature_max_05","WorldClim_2.1_GISS-E2-1-G_ssp245_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature May","max T May","may","degrees Celsius","*degree*C*", +"temperature_max_06","temperature_max_06","WorldClim_2.1_GISS-E2-1-G_ssp245_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jun","max T Jun","june","degrees Celsius","*degree*C*", +"temperature_max_07","temperature_max_07","WorldClim_2.1_GISS-E2-1-G_ssp245_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jul","max T Jul","july","degrees Celsius","*degree*C*", +"temperature_max_08","temperature_max_08","WorldClim_2.1_GISS-E2-1-G_ssp245_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Aug","max T Aug","august","degrees Celsius","*degree*C*", +"temperature_max_09","temperature_max_09","WorldClim_2.1_GISS-E2-1-G_ssp245_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Sep","max T Sep","september","degrees Celsius","*degree*C*", +"temperature_max_10","temperature_max_10","WorldClim_2.1_GISS-E2-1-G_ssp245_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Oct","max T Oct","october","degrees Celsius","*degree*C*", +"temperature_max_11","temperature_max_11","WorldClim_2.1_GISS-E2-1-G_ssp245_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Nov","max T Nov","november","degrees Celsius","*degree*C*", +"temperature_max_12","temperature_max_12","WorldClim_2.1_GISS-E2-1-G_ssp245_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Dec","max T Dec","december","degrees Celsius","*degree*C*", +"bio01","bio01","WorldClim_2.1_GISS-E2-1-G_ssp370_10m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual mean temperature","ann. mean T","year","degrees Celsius","*degree*C*", +"bio02","bio02","WorldClim_2.1_GISS-E2-1-G_ssp370_10m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean diurnal range","diurn. range","year","degrees Celsius","*degree*C*", +"bio03","bio03","WorldClim_2.1_GISS-E2-1-G_ssp370_10m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","isothermality","isothermality","year","","", +"bio04","bio04","WorldClim_2.1_GISS-E2-1-G_ssp370_10m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature seasonality","T season.","year","degrees Celsius","*degree*C*", +"bio05","bio05","WorldClim_2.1_GISS-E2-1-G_ssp370_10m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature of warmest month","max. T of warmest mo.","year","degrees Celsius","*degree*C*", +"bio06","bio06","WorldClim_2.1_GISS-E2-1-G_ssp370_10m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature of coldest month","min. T of coldest mo.","year","degrees Celsius","*degree*C*", +"bio07","bio07","WorldClim_2.1_GISS-E2-1-G_ssp370_10m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature annual range (bio05-bio06)","T ann. Range","year","degrees Celsius","*degree*C*", +"bio08","bio08","WorldClim_2.1_GISS-E2-1-G_ssp370_10m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of wettest quarter","mean T of wettest qtr","year","degrees Celsius","*degree*C*", +"bio09","bio09","WorldClim_2.1_GISS-E2-1-G_ssp370_10m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of driest quarter","mean T of driest qtr","year","degrees Celsius","*degree*C*", +"bio10","bio10","WorldClim_2.1_GISS-E2-1-G_ssp370_10m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of warmest quarter","mean T of warmest qtr","year","degrees Celsius","*degree*C*", +"bio11","bio11","WorldClim_2.1_GISS-E2-1-G_ssp370_10m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of coldest quarter","mean T of coldest qtr","year","degrees Celsius","*degree*C*", +"bio12","bio12","WorldClim_2.1_GISS-E2-1-G_ssp370_10m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual precipitation","ann. P","year","mm per year","*mm~yr^-1*", +"bio13","bio13","WorldClim_2.1_GISS-E2-1-G_ssp370_10m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest month","P of wettest mo.","year","mm per month","*mm~mo^-1*", +"bio14","bio14","WorldClim_2.1_GISS-E2-1-G_ssp370_10m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest month","P of driest mo.","year","mm per month","*mm~mo^-1*", +"bio15","bio15","WorldClim_2.1_GISS-E2-1-G_ssp370_10m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation seasonality (coeff var)","P season.","year","","", +"bio16","bio16","WorldClim_2.1_GISS-E2-1-G_ssp370_10m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest quarter","P of wettest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio17","bio17","WorldClim_2.1_GISS-E2-1-G_ssp370_10m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest quarter","P of driest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio18","bio18","WorldClim_2.1_GISS-E2-1-G_ssp370_10m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of warmest quarter","P of warmest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio19","bio19","WorldClim_2.1_GISS-E2-1-G_ssp370_10m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of coldest quarter","P of coldest qtr","year","mm per quarter","*mm~qtr^-1*", +"precipitation_01","precipitation_01","WorldClim_2.1_GISS-E2-1-G_ssp370_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jan","P Jan","january","mm per month","*mm~mo^-1*", +"precipitation_02","precipitation_02","WorldClim_2.1_GISS-E2-1-G_ssp370_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Feb","P Feb","february","mm per month","*mm~mo^-1*", +"precipitation_03","precipitation_03","WorldClim_2.1_GISS-E2-1-G_ssp370_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Mar","P Mar","march","mm per month","*mm~mo^-1*", +"precipitation_04","precipitation_04","WorldClim_2.1_GISS-E2-1-G_ssp370_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Apr","P Apr","april","mm per month","*mm~mo^-1*", +"precipitation_05","precipitation_05","WorldClim_2.1_GISS-E2-1-G_ssp370_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation May","P May","may","mm per month","*mm~mo^-1*", +"precipitation_06","precipitation_06","WorldClim_2.1_GISS-E2-1-G_ssp370_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jun","P Jun","june","mm per month","*mm~mo^-1*", +"precipitation_07","precipitation_07","WorldClim_2.1_GISS-E2-1-G_ssp370_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jul","P Jul","july","mm per month","*mm~mo^-1*", +"precipitation_08","precipitation_08","WorldClim_2.1_GISS-E2-1-G_ssp370_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Aug","P Aug","august","mm per month","*mm~mo^-1*", +"precipitation_09","precipitation_09","WorldClim_2.1_GISS-E2-1-G_ssp370_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Sep","P Sep","september","mm per month","*mm~mo^-1*", +"precipitation_10","precipitation_10","WorldClim_2.1_GISS-E2-1-G_ssp370_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Oct","P Oct","october","mm per month","*mm~mo^-1*", +"precipitation_11","precipitation_11","WorldClim_2.1_GISS-E2-1-G_ssp370_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Nov","P Nov","november","mm per month","*mm~mo^-1*", +"precipitation_12","precipitation_12","WorldClim_2.1_GISS-E2-1-G_ssp370_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Dec","P Dec","december","mm per month","*mm~mo^-1*", +"temperature_min_01","temperature_min_01","WorldClim_2.1_GISS-E2-1-G_ssp370_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jan","min T Jan","january","degrees Celsius","*degree*C*", +"temperature_min_02","temperature_min_02","WorldClim_2.1_GISS-E2-1-G_ssp370_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Feb","min T Feb","february","degrees Celsius","*degree*C*", +"temperature_min_03","temperature_min_03","WorldClim_2.1_GISS-E2-1-G_ssp370_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Mar","min T Mar","march","degrees Celsius","*degree*C*", +"temperature_min_04","temperature_min_04","WorldClim_2.1_GISS-E2-1-G_ssp370_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Apr","min T Apr","april","degrees Celsius","*degree*C*", +"temperature_min_05","temperature_min_05","WorldClim_2.1_GISS-E2-1-G_ssp370_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature May","min T May","may","degrees Celsius","*degree*C*", +"temperature_min_06","temperature_min_06","WorldClim_2.1_GISS-E2-1-G_ssp370_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jun","min T Jun","june","degrees Celsius","*degree*C*", +"temperature_min_07","temperature_min_07","WorldClim_2.1_GISS-E2-1-G_ssp370_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jul","min T Jul","july","degrees Celsius","*degree*C*", +"temperature_min_08","temperature_min_08","WorldClim_2.1_GISS-E2-1-G_ssp370_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Aug","min T Aug","august","degrees Celsius","*degree*C*", +"temperature_min_09","temperature_min_09","WorldClim_2.1_GISS-E2-1-G_ssp370_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Sep","min T Sep","september","degrees Celsius","*degree*C*", +"temperature_min_10","temperature_min_10","WorldClim_2.1_GISS-E2-1-G_ssp370_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Oct","min T Oct","october","degrees Celsius","*degree*C*", +"temperature_min_11","temperature_min_11","WorldClim_2.1_GISS-E2-1-G_ssp370_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Nov","min T Nov","november","degrees Celsius","*degree*C*", +"temperature_min_12","temperature_min_12","WorldClim_2.1_GISS-E2-1-G_ssp370_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Dec","min T Dec","december","degrees Celsius","*degree*C*", +"temperature_max_01","temperature_max_01","WorldClim_2.1_GISS-E2-1-G_ssp370_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jan","max T Jan","january","degrees Celsius","*degree*C*", +"temperature_max_02","temperature_max_02","WorldClim_2.1_GISS-E2-1-G_ssp370_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Feb","max T Feb","february","degrees Celsius","*degree*C*", +"temperature_max_03","temperature_max_03","WorldClim_2.1_GISS-E2-1-G_ssp370_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Mar","max T Mar","march","degrees Celsius","*degree*C*", +"temperature_max_04","temperature_max_04","WorldClim_2.1_GISS-E2-1-G_ssp370_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Apr","max T Apr","april","degrees Celsius","*degree*C*", +"temperature_max_05","temperature_max_05","WorldClim_2.1_GISS-E2-1-G_ssp370_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature May","max T May","may","degrees Celsius","*degree*C*", +"temperature_max_06","temperature_max_06","WorldClim_2.1_GISS-E2-1-G_ssp370_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jun","max T Jun","june","degrees Celsius","*degree*C*", +"temperature_max_07","temperature_max_07","WorldClim_2.1_GISS-E2-1-G_ssp370_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jul","max T Jul","july","degrees Celsius","*degree*C*", +"temperature_max_08","temperature_max_08","WorldClim_2.1_GISS-E2-1-G_ssp370_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Aug","max T Aug","august","degrees Celsius","*degree*C*", +"temperature_max_09","temperature_max_09","WorldClim_2.1_GISS-E2-1-G_ssp370_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Sep","max T Sep","september","degrees Celsius","*degree*C*", +"temperature_max_10","temperature_max_10","WorldClim_2.1_GISS-E2-1-G_ssp370_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Oct","max T Oct","october","degrees Celsius","*degree*C*", +"temperature_max_11","temperature_max_11","WorldClim_2.1_GISS-E2-1-G_ssp370_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Nov","max T Nov","november","degrees Celsius","*degree*C*", +"temperature_max_12","temperature_max_12","WorldClim_2.1_GISS-E2-1-G_ssp370_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Dec","max T Dec","december","degrees Celsius","*degree*C*", +"bio01","bio01","WorldClim_2.1_GISS-E2-1-G_ssp370_5m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual mean temperature","ann. mean T","year","degrees Celsius","*degree*C*", +"bio02","bio02","WorldClim_2.1_GISS-E2-1-G_ssp370_5m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean diurnal range","diurn. range","year","degrees Celsius","*degree*C*", +"bio03","bio03","WorldClim_2.1_GISS-E2-1-G_ssp370_5m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","isothermality","isothermality","year","","", +"bio04","bio04","WorldClim_2.1_GISS-E2-1-G_ssp370_5m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature seasonality","T season.","year","degrees Celsius","*degree*C*", +"bio05","bio05","WorldClim_2.1_GISS-E2-1-G_ssp370_5m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature of warmest month","max. T of warmest mo.","year","degrees Celsius","*degree*C*", +"bio06","bio06","WorldClim_2.1_GISS-E2-1-G_ssp370_5m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature of coldest month","min. T of coldest mo.","year","degrees Celsius","*degree*C*", +"bio07","bio07","WorldClim_2.1_GISS-E2-1-G_ssp370_5m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature annual range (bio05-bio06)","T ann. Range","year","degrees Celsius","*degree*C*", +"bio08","bio08","WorldClim_2.1_GISS-E2-1-G_ssp370_5m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of wettest quarter","mean T of wettest qtr","year","degrees Celsius","*degree*C*", +"bio09","bio09","WorldClim_2.1_GISS-E2-1-G_ssp370_5m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of driest quarter","mean T of driest qtr","year","degrees Celsius","*degree*C*", +"bio10","bio10","WorldClim_2.1_GISS-E2-1-G_ssp370_5m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of warmest quarter","mean T of warmest qtr","year","degrees Celsius","*degree*C*", +"bio11","bio11","WorldClim_2.1_GISS-E2-1-G_ssp370_5m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of coldest quarter","mean T of coldest qtr","year","degrees Celsius","*degree*C*", +"bio12","bio12","WorldClim_2.1_GISS-E2-1-G_ssp370_5m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual precipitation","ann. P","year","mm per year","*mm~yr^-1*", +"bio13","bio13","WorldClim_2.1_GISS-E2-1-G_ssp370_5m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest month","P of wettest mo.","year","mm per month","*mm~mo^-1*", +"bio14","bio14","WorldClim_2.1_GISS-E2-1-G_ssp370_5m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest month","P of driest mo.","year","mm per month","*mm~mo^-1*", +"bio15","bio15","WorldClim_2.1_GISS-E2-1-G_ssp370_5m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation seasonality (coeff var)","P season.","year","","", +"bio16","bio16","WorldClim_2.1_GISS-E2-1-G_ssp370_5m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest quarter","P of wettest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio17","bio17","WorldClim_2.1_GISS-E2-1-G_ssp370_5m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest quarter","P of driest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio18","bio18","WorldClim_2.1_GISS-E2-1-G_ssp370_5m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of warmest quarter","P of warmest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio19","bio19","WorldClim_2.1_GISS-E2-1-G_ssp370_5m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of coldest quarter","P of coldest qtr","year","mm per quarter","*mm~qtr^-1*", +"precipitation_01","precipitation_01","WorldClim_2.1_GISS-E2-1-G_ssp370_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jan","P Jan","january","mm per month","*mm~mo^-1*", +"precipitation_02","precipitation_02","WorldClim_2.1_GISS-E2-1-G_ssp370_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Feb","P Feb","february","mm per month","*mm~mo^-1*", +"precipitation_03","precipitation_03","WorldClim_2.1_GISS-E2-1-G_ssp370_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Mar","P Mar","march","mm per month","*mm~mo^-1*", +"precipitation_04","precipitation_04","WorldClim_2.1_GISS-E2-1-G_ssp370_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Apr","P Apr","april","mm per month","*mm~mo^-1*", +"precipitation_05","precipitation_05","WorldClim_2.1_GISS-E2-1-G_ssp370_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation May","P May","may","mm per month","*mm~mo^-1*", +"precipitation_06","precipitation_06","WorldClim_2.1_GISS-E2-1-G_ssp370_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jun","P Jun","june","mm per month","*mm~mo^-1*", +"precipitation_07","precipitation_07","WorldClim_2.1_GISS-E2-1-G_ssp370_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jul","P Jul","july","mm per month","*mm~mo^-1*", +"precipitation_08","precipitation_08","WorldClim_2.1_GISS-E2-1-G_ssp370_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Aug","P Aug","august","mm per month","*mm~mo^-1*", +"precipitation_09","precipitation_09","WorldClim_2.1_GISS-E2-1-G_ssp370_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Sep","P Sep","september","mm per month","*mm~mo^-1*", +"precipitation_10","precipitation_10","WorldClim_2.1_GISS-E2-1-G_ssp370_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Oct","P Oct","october","mm per month","*mm~mo^-1*", +"precipitation_11","precipitation_11","WorldClim_2.1_GISS-E2-1-G_ssp370_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Nov","P Nov","november","mm per month","*mm~mo^-1*", +"precipitation_12","precipitation_12","WorldClim_2.1_GISS-E2-1-G_ssp370_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Dec","P Dec","december","mm per month","*mm~mo^-1*", +"temperature_min_01","temperature_min_01","WorldClim_2.1_GISS-E2-1-G_ssp370_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jan","min T Jan","january","degrees Celsius","*degree*C*", +"temperature_min_02","temperature_min_02","WorldClim_2.1_GISS-E2-1-G_ssp370_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Feb","min T Feb","february","degrees Celsius","*degree*C*", +"temperature_min_03","temperature_min_03","WorldClim_2.1_GISS-E2-1-G_ssp370_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Mar","min T Mar","march","degrees Celsius","*degree*C*", +"temperature_min_04","temperature_min_04","WorldClim_2.1_GISS-E2-1-G_ssp370_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Apr","min T Apr","april","degrees Celsius","*degree*C*", +"temperature_min_05","temperature_min_05","WorldClim_2.1_GISS-E2-1-G_ssp370_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature May","min T May","may","degrees Celsius","*degree*C*", +"temperature_min_06","temperature_min_06","WorldClim_2.1_GISS-E2-1-G_ssp370_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jun","min T Jun","june","degrees Celsius","*degree*C*", +"temperature_min_07","temperature_min_07","WorldClim_2.1_GISS-E2-1-G_ssp370_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jul","min T Jul","july","degrees Celsius","*degree*C*", +"temperature_min_08","temperature_min_08","WorldClim_2.1_GISS-E2-1-G_ssp370_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Aug","min T Aug","august","degrees Celsius","*degree*C*", +"temperature_min_09","temperature_min_09","WorldClim_2.1_GISS-E2-1-G_ssp370_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Sep","min T Sep","september","degrees Celsius","*degree*C*", +"temperature_min_10","temperature_min_10","WorldClim_2.1_GISS-E2-1-G_ssp370_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Oct","min T Oct","october","degrees Celsius","*degree*C*", +"temperature_min_11","temperature_min_11","WorldClim_2.1_GISS-E2-1-G_ssp370_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Nov","min T Nov","november","degrees Celsius","*degree*C*", +"temperature_min_12","temperature_min_12","WorldClim_2.1_GISS-E2-1-G_ssp370_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Dec","min T Dec","december","degrees Celsius","*degree*C*", +"temperature_max_01","temperature_max_01","WorldClim_2.1_GISS-E2-1-G_ssp370_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jan","max T Jan","january","degrees Celsius","*degree*C*", +"temperature_max_02","temperature_max_02","WorldClim_2.1_GISS-E2-1-G_ssp370_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Feb","max T Feb","february","degrees Celsius","*degree*C*", +"temperature_max_03","temperature_max_03","WorldClim_2.1_GISS-E2-1-G_ssp370_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Mar","max T Mar","march","degrees Celsius","*degree*C*", +"temperature_max_04","temperature_max_04","WorldClim_2.1_GISS-E2-1-G_ssp370_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Apr","max T Apr","april","degrees Celsius","*degree*C*", +"temperature_max_05","temperature_max_05","WorldClim_2.1_GISS-E2-1-G_ssp370_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature May","max T May","may","degrees Celsius","*degree*C*", +"temperature_max_06","temperature_max_06","WorldClim_2.1_GISS-E2-1-G_ssp370_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jun","max T Jun","june","degrees Celsius","*degree*C*", +"temperature_max_07","temperature_max_07","WorldClim_2.1_GISS-E2-1-G_ssp370_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jul","max T Jul","july","degrees Celsius","*degree*C*", +"temperature_max_08","temperature_max_08","WorldClim_2.1_GISS-E2-1-G_ssp370_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Aug","max T Aug","august","degrees Celsius","*degree*C*", +"temperature_max_09","temperature_max_09","WorldClim_2.1_GISS-E2-1-G_ssp370_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Sep","max T Sep","september","degrees Celsius","*degree*C*", +"temperature_max_10","temperature_max_10","WorldClim_2.1_GISS-E2-1-G_ssp370_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Oct","max T Oct","october","degrees Celsius","*degree*C*", +"temperature_max_11","temperature_max_11","WorldClim_2.1_GISS-E2-1-G_ssp370_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Nov","max T Nov","november","degrees Celsius","*degree*C*", +"temperature_max_12","temperature_max_12","WorldClim_2.1_GISS-E2-1-G_ssp370_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Dec","max T Dec","december","degrees Celsius","*degree*C*", +"bio01","bio01","WorldClim_2.1_GISS-E2-1-G_ssp585_10m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual mean temperature","ann. mean T","year","degrees Celsius","*degree*C*", +"bio02","bio02","WorldClim_2.1_GISS-E2-1-G_ssp585_10m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean diurnal range","diurn. range","year","degrees Celsius","*degree*C*", +"bio03","bio03","WorldClim_2.1_GISS-E2-1-G_ssp585_10m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","isothermality","isothermality","year","","", +"bio04","bio04","WorldClim_2.1_GISS-E2-1-G_ssp585_10m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature seasonality","T season.","year","degrees Celsius","*degree*C*", +"bio05","bio05","WorldClim_2.1_GISS-E2-1-G_ssp585_10m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature of warmest month","max. T of warmest mo.","year","degrees Celsius","*degree*C*", +"bio06","bio06","WorldClim_2.1_GISS-E2-1-G_ssp585_10m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature of coldest month","min. T of coldest mo.","year","degrees Celsius","*degree*C*", +"bio07","bio07","WorldClim_2.1_GISS-E2-1-G_ssp585_10m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature annual range (bio05-bio06)","T ann. Range","year","degrees Celsius","*degree*C*", +"bio08","bio08","WorldClim_2.1_GISS-E2-1-G_ssp585_10m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of wettest quarter","mean T of wettest qtr","year","degrees Celsius","*degree*C*", +"bio09","bio09","WorldClim_2.1_GISS-E2-1-G_ssp585_10m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of driest quarter","mean T of driest qtr","year","degrees Celsius","*degree*C*", +"bio10","bio10","WorldClim_2.1_GISS-E2-1-G_ssp585_10m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of warmest quarter","mean T of warmest qtr","year","degrees Celsius","*degree*C*", +"bio11","bio11","WorldClim_2.1_GISS-E2-1-G_ssp585_10m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of coldest quarter","mean T of coldest qtr","year","degrees Celsius","*degree*C*", +"bio12","bio12","WorldClim_2.1_GISS-E2-1-G_ssp585_10m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual precipitation","ann. P","year","mm per year","*mm~yr^-1*", +"bio13","bio13","WorldClim_2.1_GISS-E2-1-G_ssp585_10m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest month","P of wettest mo.","year","mm per month","*mm~mo^-1*", +"bio14","bio14","WorldClim_2.1_GISS-E2-1-G_ssp585_10m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest month","P of driest mo.","year","mm per month","*mm~mo^-1*", +"bio15","bio15","WorldClim_2.1_GISS-E2-1-G_ssp585_10m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation seasonality (coeff var)","P season.","year","","", +"bio16","bio16","WorldClim_2.1_GISS-E2-1-G_ssp585_10m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest quarter","P of wettest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio17","bio17","WorldClim_2.1_GISS-E2-1-G_ssp585_10m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest quarter","P of driest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio18","bio18","WorldClim_2.1_GISS-E2-1-G_ssp585_10m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of warmest quarter","P of warmest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio19","bio19","WorldClim_2.1_GISS-E2-1-G_ssp585_10m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of coldest quarter","P of coldest qtr","year","mm per quarter","*mm~qtr^-1*", +"precipitation_01","precipitation_01","WorldClim_2.1_GISS-E2-1-G_ssp585_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jan","P Jan","january","mm per month","*mm~mo^-1*", +"precipitation_02","precipitation_02","WorldClim_2.1_GISS-E2-1-G_ssp585_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Feb","P Feb","february","mm per month","*mm~mo^-1*", +"precipitation_03","precipitation_03","WorldClim_2.1_GISS-E2-1-G_ssp585_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Mar","P Mar","march","mm per month","*mm~mo^-1*", +"precipitation_04","precipitation_04","WorldClim_2.1_GISS-E2-1-G_ssp585_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Apr","P Apr","april","mm per month","*mm~mo^-1*", +"precipitation_05","precipitation_05","WorldClim_2.1_GISS-E2-1-G_ssp585_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation May","P May","may","mm per month","*mm~mo^-1*", +"precipitation_06","precipitation_06","WorldClim_2.1_GISS-E2-1-G_ssp585_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jun","P Jun","june","mm per month","*mm~mo^-1*", +"precipitation_07","precipitation_07","WorldClim_2.1_GISS-E2-1-G_ssp585_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jul","P Jul","july","mm per month","*mm~mo^-1*", +"precipitation_08","precipitation_08","WorldClim_2.1_GISS-E2-1-G_ssp585_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Aug","P Aug","august","mm per month","*mm~mo^-1*", +"precipitation_09","precipitation_09","WorldClim_2.1_GISS-E2-1-G_ssp585_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Sep","P Sep","september","mm per month","*mm~mo^-1*", +"precipitation_10","precipitation_10","WorldClim_2.1_GISS-E2-1-G_ssp585_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Oct","P Oct","october","mm per month","*mm~mo^-1*", +"precipitation_11","precipitation_11","WorldClim_2.1_GISS-E2-1-G_ssp585_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Nov","P Nov","november","mm per month","*mm~mo^-1*", +"precipitation_12","precipitation_12","WorldClim_2.1_GISS-E2-1-G_ssp585_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Dec","P Dec","december","mm per month","*mm~mo^-1*", +"temperature_min_01","temperature_min_01","WorldClim_2.1_GISS-E2-1-G_ssp585_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jan","min T Jan","january","degrees Celsius","*degree*C*", +"temperature_min_02","temperature_min_02","WorldClim_2.1_GISS-E2-1-G_ssp585_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Feb","min T Feb","february","degrees Celsius","*degree*C*", +"temperature_min_03","temperature_min_03","WorldClim_2.1_GISS-E2-1-G_ssp585_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Mar","min T Mar","march","degrees Celsius","*degree*C*", +"temperature_min_04","temperature_min_04","WorldClim_2.1_GISS-E2-1-G_ssp585_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Apr","min T Apr","april","degrees Celsius","*degree*C*", +"temperature_min_05","temperature_min_05","WorldClim_2.1_GISS-E2-1-G_ssp585_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature May","min T May","may","degrees Celsius","*degree*C*", +"temperature_min_06","temperature_min_06","WorldClim_2.1_GISS-E2-1-G_ssp585_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jun","min T Jun","june","degrees Celsius","*degree*C*", +"temperature_min_07","temperature_min_07","WorldClim_2.1_GISS-E2-1-G_ssp585_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jul","min T Jul","july","degrees Celsius","*degree*C*", +"temperature_min_08","temperature_min_08","WorldClim_2.1_GISS-E2-1-G_ssp585_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Aug","min T Aug","august","degrees Celsius","*degree*C*", +"temperature_min_09","temperature_min_09","WorldClim_2.1_GISS-E2-1-G_ssp585_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Sep","min T Sep","september","degrees Celsius","*degree*C*", +"temperature_min_10","temperature_min_10","WorldClim_2.1_GISS-E2-1-G_ssp585_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Oct","min T Oct","october","degrees Celsius","*degree*C*", +"temperature_min_11","temperature_min_11","WorldClim_2.1_GISS-E2-1-G_ssp585_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Nov","min T Nov","november","degrees Celsius","*degree*C*", +"temperature_min_12","temperature_min_12","WorldClim_2.1_GISS-E2-1-G_ssp585_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Dec","min T Dec","december","degrees Celsius","*degree*C*", +"temperature_max_01","temperature_max_01","WorldClim_2.1_GISS-E2-1-G_ssp585_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jan","max T Jan","january","degrees Celsius","*degree*C*", +"temperature_max_02","temperature_max_02","WorldClim_2.1_GISS-E2-1-G_ssp585_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Feb","max T Feb","february","degrees Celsius","*degree*C*", +"temperature_max_03","temperature_max_03","WorldClim_2.1_GISS-E2-1-G_ssp585_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Mar","max T Mar","march","degrees Celsius","*degree*C*", +"temperature_max_04","temperature_max_04","WorldClim_2.1_GISS-E2-1-G_ssp585_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Apr","max T Apr","april","degrees Celsius","*degree*C*", +"temperature_max_05","temperature_max_05","WorldClim_2.1_GISS-E2-1-G_ssp585_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature May","max T May","may","degrees Celsius","*degree*C*", +"temperature_max_06","temperature_max_06","WorldClim_2.1_GISS-E2-1-G_ssp585_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jun","max T Jun","june","degrees Celsius","*degree*C*", +"temperature_max_07","temperature_max_07","WorldClim_2.1_GISS-E2-1-G_ssp585_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jul","max T Jul","july","degrees Celsius","*degree*C*", +"temperature_max_08","temperature_max_08","WorldClim_2.1_GISS-E2-1-G_ssp585_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Aug","max T Aug","august","degrees Celsius","*degree*C*", +"temperature_max_09","temperature_max_09","WorldClim_2.1_GISS-E2-1-G_ssp585_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Sep","max T Sep","september","degrees Celsius","*degree*C*", +"temperature_max_10","temperature_max_10","WorldClim_2.1_GISS-E2-1-G_ssp585_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Oct","max T Oct","october","degrees Celsius","*degree*C*", +"temperature_max_11","temperature_max_11","WorldClim_2.1_GISS-E2-1-G_ssp585_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Nov","max T Nov","november","degrees Celsius","*degree*C*", +"temperature_max_12","temperature_max_12","WorldClim_2.1_GISS-E2-1-G_ssp585_10m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Dec","max T Dec","december","degrees Celsius","*degree*C*", +"bio01","bio01","WorldClim_2.1_GISS-E2-1-G_ssp585_5m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual mean temperature","ann. mean T","year","degrees Celsius","*degree*C*", +"bio02","bio02","WorldClim_2.1_GISS-E2-1-G_ssp585_5m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean diurnal range","diurn. range","year","degrees Celsius","*degree*C*", +"bio03","bio03","WorldClim_2.1_GISS-E2-1-G_ssp585_5m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","isothermality","isothermality","year","","", +"bio04","bio04","WorldClim_2.1_GISS-E2-1-G_ssp585_5m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature seasonality","T season.","year","degrees Celsius","*degree*C*", +"bio05","bio05","WorldClim_2.1_GISS-E2-1-G_ssp585_5m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature of warmest month","max. T of warmest mo.","year","degrees Celsius","*degree*C*", +"bio06","bio06","WorldClim_2.1_GISS-E2-1-G_ssp585_5m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature of coldest month","min. T of coldest mo.","year","degrees Celsius","*degree*C*", +"bio07","bio07","WorldClim_2.1_GISS-E2-1-G_ssp585_5m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature annual range (bio05-bio06)","T ann. Range","year","degrees Celsius","*degree*C*", +"bio08","bio08","WorldClim_2.1_GISS-E2-1-G_ssp585_5m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of wettest quarter","mean T of wettest qtr","year","degrees Celsius","*degree*C*", +"bio09","bio09","WorldClim_2.1_GISS-E2-1-G_ssp585_5m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of driest quarter","mean T of driest qtr","year","degrees Celsius","*degree*C*", +"bio10","bio10","WorldClim_2.1_GISS-E2-1-G_ssp585_5m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of warmest quarter","mean T of warmest qtr","year","degrees Celsius","*degree*C*", +"bio11","bio11","WorldClim_2.1_GISS-E2-1-G_ssp585_5m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of coldest quarter","mean T of coldest qtr","year","degrees Celsius","*degree*C*", +"bio12","bio12","WorldClim_2.1_GISS-E2-1-G_ssp585_5m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual precipitation","ann. P","year","mm per year","*mm~yr^-1*", +"bio13","bio13","WorldClim_2.1_GISS-E2-1-G_ssp585_5m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest month","P of wettest mo.","year","mm per month","*mm~mo^-1*", +"bio14","bio14","WorldClim_2.1_GISS-E2-1-G_ssp585_5m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest month","P of driest mo.","year","mm per month","*mm~mo^-1*", +"bio15","bio15","WorldClim_2.1_GISS-E2-1-G_ssp585_5m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation seasonality (coeff var)","P season.","year","","", +"bio16","bio16","WorldClim_2.1_GISS-E2-1-G_ssp585_5m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest quarter","P of wettest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio17","bio17","WorldClim_2.1_GISS-E2-1-G_ssp585_5m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest quarter","P of driest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio18","bio18","WorldClim_2.1_GISS-E2-1-G_ssp585_5m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of warmest quarter","P of warmest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio19","bio19","WorldClim_2.1_GISS-E2-1-G_ssp585_5m",FALSE,"WorldClim_2.1_GISS-E2-1-G_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of coldest quarter","P of coldest qtr","year","mm per quarter","*mm~qtr^-1*", +"precipitation_01","precipitation_01","WorldClim_2.1_GISS-E2-1-G_ssp585_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jan","P Jan","january","mm per month","*mm~mo^-1*", +"precipitation_02","precipitation_02","WorldClim_2.1_GISS-E2-1-G_ssp585_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Feb","P Feb","february","mm per month","*mm~mo^-1*", +"precipitation_03","precipitation_03","WorldClim_2.1_GISS-E2-1-G_ssp585_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Mar","P Mar","march","mm per month","*mm~mo^-1*", +"precipitation_04","precipitation_04","WorldClim_2.1_GISS-E2-1-G_ssp585_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Apr","P Apr","april","mm per month","*mm~mo^-1*", +"precipitation_05","precipitation_05","WorldClim_2.1_GISS-E2-1-G_ssp585_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation May","P May","may","mm per month","*mm~mo^-1*", +"precipitation_06","precipitation_06","WorldClim_2.1_GISS-E2-1-G_ssp585_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jun","P Jun","june","mm per month","*mm~mo^-1*", +"precipitation_07","precipitation_07","WorldClim_2.1_GISS-E2-1-G_ssp585_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jul","P Jul","july","mm per month","*mm~mo^-1*", +"precipitation_08","precipitation_08","WorldClim_2.1_GISS-E2-1-G_ssp585_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Aug","P Aug","august","mm per month","*mm~mo^-1*", +"precipitation_09","precipitation_09","WorldClim_2.1_GISS-E2-1-G_ssp585_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Sep","P Sep","september","mm per month","*mm~mo^-1*", +"precipitation_10","precipitation_10","WorldClim_2.1_GISS-E2-1-G_ssp585_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Oct","P Oct","october","mm per month","*mm~mo^-1*", +"precipitation_11","precipitation_11","WorldClim_2.1_GISS-E2-1-G_ssp585_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Nov","P Nov","november","mm per month","*mm~mo^-1*", +"precipitation_12","precipitation_12","WorldClim_2.1_GISS-E2-1-G_ssp585_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Dec","P Dec","december","mm per month","*mm~mo^-1*", +"temperature_min_01","temperature_min_01","WorldClim_2.1_GISS-E2-1-G_ssp585_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jan","min T Jan","january","degrees Celsius","*degree*C*", +"temperature_min_02","temperature_min_02","WorldClim_2.1_GISS-E2-1-G_ssp585_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Feb","min T Feb","february","degrees Celsius","*degree*C*", +"temperature_min_03","temperature_min_03","WorldClim_2.1_GISS-E2-1-G_ssp585_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Mar","min T Mar","march","degrees Celsius","*degree*C*", +"temperature_min_04","temperature_min_04","WorldClim_2.1_GISS-E2-1-G_ssp585_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Apr","min T Apr","april","degrees Celsius","*degree*C*", +"temperature_min_05","temperature_min_05","WorldClim_2.1_GISS-E2-1-G_ssp585_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature May","min T May","may","degrees Celsius","*degree*C*", +"temperature_min_06","temperature_min_06","WorldClim_2.1_GISS-E2-1-G_ssp585_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jun","min T Jun","june","degrees Celsius","*degree*C*", +"temperature_min_07","temperature_min_07","WorldClim_2.1_GISS-E2-1-G_ssp585_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jul","min T Jul","july","degrees Celsius","*degree*C*", +"temperature_min_08","temperature_min_08","WorldClim_2.1_GISS-E2-1-G_ssp585_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Aug","min T Aug","august","degrees Celsius","*degree*C*", +"temperature_min_09","temperature_min_09","WorldClim_2.1_GISS-E2-1-G_ssp585_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Sep","min T Sep","september","degrees Celsius","*degree*C*", +"temperature_min_10","temperature_min_10","WorldClim_2.1_GISS-E2-1-G_ssp585_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Oct","min T Oct","october","degrees Celsius","*degree*C*", +"temperature_min_11","temperature_min_11","WorldClim_2.1_GISS-E2-1-G_ssp585_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Nov","min T Nov","november","degrees Celsius","*degree*C*", +"temperature_min_12","temperature_min_12","WorldClim_2.1_GISS-E2-1-G_ssp585_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Dec","min T Dec","december","degrees Celsius","*degree*C*", +"temperature_max_01","temperature_max_01","WorldClim_2.1_GISS-E2-1-G_ssp585_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jan","max T Jan","january","degrees Celsius","*degree*C*", +"temperature_max_02","temperature_max_02","WorldClim_2.1_GISS-E2-1-G_ssp585_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Feb","max T Feb","february","degrees Celsius","*degree*C*", +"temperature_max_03","temperature_max_03","WorldClim_2.1_GISS-E2-1-G_ssp585_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Mar","max T Mar","march","degrees Celsius","*degree*C*", +"temperature_max_04","temperature_max_04","WorldClim_2.1_GISS-E2-1-G_ssp585_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Apr","max T Apr","april","degrees Celsius","*degree*C*", +"temperature_max_05","temperature_max_05","WorldClim_2.1_GISS-E2-1-G_ssp585_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature May","max T May","may","degrees Celsius","*degree*C*", +"temperature_max_06","temperature_max_06","WorldClim_2.1_GISS-E2-1-G_ssp585_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jun","max T Jun","june","degrees Celsius","*degree*C*", +"temperature_max_07","temperature_max_07","WorldClim_2.1_GISS-E2-1-G_ssp585_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jul","max T Jul","july","degrees Celsius","*degree*C*", +"temperature_max_08","temperature_max_08","WorldClim_2.1_GISS-E2-1-G_ssp585_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Aug","max T Aug","august","degrees Celsius","*degree*C*", +"temperature_max_09","temperature_max_09","WorldClim_2.1_GISS-E2-1-G_ssp585_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Sep","max T Sep","september","degrees Celsius","*degree*C*", +"temperature_max_10","temperature_max_10","WorldClim_2.1_GISS-E2-1-G_ssp585_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Oct","max T Oct","october","degrees Celsius","*degree*C*", +"temperature_max_11","temperature_max_11","WorldClim_2.1_GISS-E2-1-G_ssp585_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Nov","max T Nov","november","degrees Celsius","*degree*C*", +"temperature_max_12","temperature_max_12","WorldClim_2.1_GISS-E2-1-G_ssp585_5m",TRUE,"WorldClim_2.1_GISS-E2-1-G_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Dec","max T Dec","december","degrees Celsius","*degree*C*", +"bio01","bio01","WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual mean temperature","ann. mean T","year","degrees Celsius","*degree*C*", +"bio02","bio02","WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean diurnal range","diurn. range","year","degrees Celsius","*degree*C*", +"bio03","bio03","WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","isothermality","isothermality","year","","", +"bio04","bio04","WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature seasonality","T season.","year","degrees Celsius","*degree*C*", +"bio05","bio05","WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature of warmest month","max. T of warmest mo.","year","degrees Celsius","*degree*C*", +"bio06","bio06","WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature of coldest month","min. T of coldest mo.","year","degrees Celsius","*degree*C*", +"bio07","bio07","WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature annual range (bio05-bio06)","T ann. Range","year","degrees Celsius","*degree*C*", +"bio08","bio08","WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of wettest quarter","mean T of wettest qtr","year","degrees Celsius","*degree*C*", +"bio09","bio09","WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of driest quarter","mean T of driest qtr","year","degrees Celsius","*degree*C*", +"bio10","bio10","WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of warmest quarter","mean T of warmest qtr","year","degrees Celsius","*degree*C*", +"bio11","bio11","WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of coldest quarter","mean T of coldest qtr","year","degrees Celsius","*degree*C*", +"bio12","bio12","WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual precipitation","ann. P","year","mm per year","*mm~yr^-1*", +"bio13","bio13","WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest month","P of wettest mo.","year","mm per month","*mm~mo^-1*", +"bio14","bio14","WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest month","P of driest mo.","year","mm per month","*mm~mo^-1*", +"bio15","bio15","WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation seasonality (coeff var)","P season.","year","","", +"bio16","bio16","WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest quarter","P of wettest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio17","bio17","WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest quarter","P of driest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio18","bio18","WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of warmest quarter","P of warmest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio19","bio19","WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of coldest quarter","P of coldest qtr","year","mm per quarter","*mm~qtr^-1*", +"precipitation_01","precipitation_01","WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jan","P Jan","january","mm per month","*mm~mo^-1*", +"precipitation_02","precipitation_02","WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Feb","P Feb","february","mm per month","*mm~mo^-1*", +"precipitation_03","precipitation_03","WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Mar","P Mar","march","mm per month","*mm~mo^-1*", +"precipitation_04","precipitation_04","WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Apr","P Apr","april","mm per month","*mm~mo^-1*", +"precipitation_05","precipitation_05","WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation May","P May","may","mm per month","*mm~mo^-1*", +"precipitation_06","precipitation_06","WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jun","P Jun","june","mm per month","*mm~mo^-1*", +"precipitation_07","precipitation_07","WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jul","P Jul","july","mm per month","*mm~mo^-1*", +"precipitation_08","precipitation_08","WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Aug","P Aug","august","mm per month","*mm~mo^-1*", +"precipitation_09","precipitation_09","WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Sep","P Sep","september","mm per month","*mm~mo^-1*", +"precipitation_10","precipitation_10","WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Oct","P Oct","october","mm per month","*mm~mo^-1*", +"precipitation_11","precipitation_11","WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Nov","P Nov","november","mm per month","*mm~mo^-1*", +"precipitation_12","precipitation_12","WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Dec","P Dec","december","mm per month","*mm~mo^-1*", +"temperature_min_01","temperature_min_01","WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jan","min T Jan","january","degrees Celsius","*degree*C*", +"temperature_min_02","temperature_min_02","WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Feb","min T Feb","february","degrees Celsius","*degree*C*", +"temperature_min_03","temperature_min_03","WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Mar","min T Mar","march","degrees Celsius","*degree*C*", +"temperature_min_04","temperature_min_04","WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Apr","min T Apr","april","degrees Celsius","*degree*C*", +"temperature_min_05","temperature_min_05","WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature May","min T May","may","degrees Celsius","*degree*C*", +"temperature_min_06","temperature_min_06","WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jun","min T Jun","june","degrees Celsius","*degree*C*", +"temperature_min_07","temperature_min_07","WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jul","min T Jul","july","degrees Celsius","*degree*C*", +"temperature_min_08","temperature_min_08","WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Aug","min T Aug","august","degrees Celsius","*degree*C*", +"temperature_min_09","temperature_min_09","WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Sep","min T Sep","september","degrees Celsius","*degree*C*", +"temperature_min_10","temperature_min_10","WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Oct","min T Oct","october","degrees Celsius","*degree*C*", +"temperature_min_11","temperature_min_11","WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Nov","min T Nov","november","degrees Celsius","*degree*C*", +"temperature_min_12","temperature_min_12","WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Dec","min T Dec","december","degrees Celsius","*degree*C*", +"temperature_max_01","temperature_max_01","WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jan","max T Jan","january","degrees Celsius","*degree*C*", +"temperature_max_02","temperature_max_02","WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Feb","max T Feb","february","degrees Celsius","*degree*C*", +"temperature_max_03","temperature_max_03","WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Mar","max T Mar","march","degrees Celsius","*degree*C*", +"temperature_max_04","temperature_max_04","WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Apr","max T Apr","april","degrees Celsius","*degree*C*", +"temperature_max_05","temperature_max_05","WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature May","max T May","may","degrees Celsius","*degree*C*", +"temperature_max_06","temperature_max_06","WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jun","max T Jun","june","degrees Celsius","*degree*C*", +"temperature_max_07","temperature_max_07","WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jul","max T Jul","july","degrees Celsius","*degree*C*", +"temperature_max_08","temperature_max_08","WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Aug","max T Aug","august","degrees Celsius","*degree*C*", +"temperature_max_09","temperature_max_09","WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Sep","max T Sep","september","degrees Celsius","*degree*C*", +"temperature_max_10","temperature_max_10","WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Oct","max T Oct","october","degrees Celsius","*degree*C*", +"temperature_max_11","temperature_max_11","WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Nov","max T Nov","november","degrees Celsius","*degree*C*", +"temperature_max_12","temperature_max_12","WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Dec","max T Dec","december","degrees Celsius","*degree*C*", +"bio01","bio01","WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual mean temperature","ann. mean T","year","degrees Celsius","*degree*C*", +"bio02","bio02","WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean diurnal range","diurn. range","year","degrees Celsius","*degree*C*", +"bio03","bio03","WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","isothermality","isothermality","year","","", +"bio04","bio04","WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature seasonality","T season.","year","degrees Celsius","*degree*C*", +"bio05","bio05","WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature of warmest month","max. T of warmest mo.","year","degrees Celsius","*degree*C*", +"bio06","bio06","WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature of coldest month","min. T of coldest mo.","year","degrees Celsius","*degree*C*", +"bio07","bio07","WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature annual range (bio05-bio06)","T ann. Range","year","degrees Celsius","*degree*C*", +"bio08","bio08","WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of wettest quarter","mean T of wettest qtr","year","degrees Celsius","*degree*C*", +"bio09","bio09","WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of driest quarter","mean T of driest qtr","year","degrees Celsius","*degree*C*", +"bio10","bio10","WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of warmest quarter","mean T of warmest qtr","year","degrees Celsius","*degree*C*", +"bio11","bio11","WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of coldest quarter","mean T of coldest qtr","year","degrees Celsius","*degree*C*", +"bio12","bio12","WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual precipitation","ann. P","year","mm per year","*mm~yr^-1*", +"bio13","bio13","WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest month","P of wettest mo.","year","mm per month","*mm~mo^-1*", +"bio14","bio14","WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest month","P of driest mo.","year","mm per month","*mm~mo^-1*", +"bio15","bio15","WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation seasonality (coeff var)","P season.","year","","", +"bio16","bio16","WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest quarter","P of wettest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio17","bio17","WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest quarter","P of driest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio18","bio18","WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of warmest quarter","P of warmest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio19","bio19","WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of coldest quarter","P of coldest qtr","year","mm per quarter","*mm~qtr^-1*", +"precipitation_01","precipitation_01","WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jan","P Jan","january","mm per month","*mm~mo^-1*", +"precipitation_02","precipitation_02","WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Feb","P Feb","february","mm per month","*mm~mo^-1*", +"precipitation_03","precipitation_03","WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Mar","P Mar","march","mm per month","*mm~mo^-1*", +"precipitation_04","precipitation_04","WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Apr","P Apr","april","mm per month","*mm~mo^-1*", +"precipitation_05","precipitation_05","WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation May","P May","may","mm per month","*mm~mo^-1*", +"precipitation_06","precipitation_06","WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jun","P Jun","june","mm per month","*mm~mo^-1*", +"precipitation_07","precipitation_07","WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jul","P Jul","july","mm per month","*mm~mo^-1*", +"precipitation_08","precipitation_08","WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Aug","P Aug","august","mm per month","*mm~mo^-1*", +"precipitation_09","precipitation_09","WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Sep","P Sep","september","mm per month","*mm~mo^-1*", +"precipitation_10","precipitation_10","WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Oct","P Oct","october","mm per month","*mm~mo^-1*", +"precipitation_11","precipitation_11","WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Nov","P Nov","november","mm per month","*mm~mo^-1*", +"precipitation_12","precipitation_12","WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Dec","P Dec","december","mm per month","*mm~mo^-1*", +"temperature_min_01","temperature_min_01","WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jan","min T Jan","january","degrees Celsius","*degree*C*", +"temperature_min_02","temperature_min_02","WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Feb","min T Feb","february","degrees Celsius","*degree*C*", +"temperature_min_03","temperature_min_03","WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Mar","min T Mar","march","degrees Celsius","*degree*C*", +"temperature_min_04","temperature_min_04","WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Apr","min T Apr","april","degrees Celsius","*degree*C*", +"temperature_min_05","temperature_min_05","WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature May","min T May","may","degrees Celsius","*degree*C*", +"temperature_min_06","temperature_min_06","WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jun","min T Jun","june","degrees Celsius","*degree*C*", +"temperature_min_07","temperature_min_07","WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jul","min T Jul","july","degrees Celsius","*degree*C*", +"temperature_min_08","temperature_min_08","WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Aug","min T Aug","august","degrees Celsius","*degree*C*", +"temperature_min_09","temperature_min_09","WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Sep","min T Sep","september","degrees Celsius","*degree*C*", +"temperature_min_10","temperature_min_10","WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Oct","min T Oct","october","degrees Celsius","*degree*C*", +"temperature_min_11","temperature_min_11","WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Nov","min T Nov","november","degrees Celsius","*degree*C*", +"temperature_min_12","temperature_min_12","WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Dec","min T Dec","december","degrees Celsius","*degree*C*", +"temperature_max_01","temperature_max_01","WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jan","max T Jan","january","degrees Celsius","*degree*C*", +"temperature_max_02","temperature_max_02","WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Feb","max T Feb","february","degrees Celsius","*degree*C*", +"temperature_max_03","temperature_max_03","WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Mar","max T Mar","march","degrees Celsius","*degree*C*", +"temperature_max_04","temperature_max_04","WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Apr","max T Apr","april","degrees Celsius","*degree*C*", +"temperature_max_05","temperature_max_05","WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature May","max T May","may","degrees Celsius","*degree*C*", +"temperature_max_06","temperature_max_06","WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jun","max T Jun","june","degrees Celsius","*degree*C*", +"temperature_max_07","temperature_max_07","WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jul","max T Jul","july","degrees Celsius","*degree*C*", +"temperature_max_08","temperature_max_08","WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Aug","max T Aug","august","degrees Celsius","*degree*C*", +"temperature_max_09","temperature_max_09","WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Sep","max T Sep","september","degrees Celsius","*degree*C*", +"temperature_max_10","temperature_max_10","WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Oct","max T Oct","october","degrees Celsius","*degree*C*", +"temperature_max_11","temperature_max_11","WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Nov","max T Nov","november","degrees Celsius","*degree*C*", +"temperature_max_12","temperature_max_12","WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Dec","max T Dec","december","degrees Celsius","*degree*C*", +"bio01","bio01","WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual mean temperature","ann. mean T","year","degrees Celsius","*degree*C*", +"bio02","bio02","WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean diurnal range","diurn. range","year","degrees Celsius","*degree*C*", +"bio03","bio03","WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","isothermality","isothermality","year","","", +"bio04","bio04","WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature seasonality","T season.","year","degrees Celsius","*degree*C*", +"bio05","bio05","WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature of warmest month","max. T of warmest mo.","year","degrees Celsius","*degree*C*", +"bio06","bio06","WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature of coldest month","min. T of coldest mo.","year","degrees Celsius","*degree*C*", +"bio07","bio07","WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature annual range (bio05-bio06)","T ann. Range","year","degrees Celsius","*degree*C*", +"bio08","bio08","WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of wettest quarter","mean T of wettest qtr","year","degrees Celsius","*degree*C*", +"bio09","bio09","WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of driest quarter","mean T of driest qtr","year","degrees Celsius","*degree*C*", +"bio10","bio10","WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of warmest quarter","mean T of warmest qtr","year","degrees Celsius","*degree*C*", +"bio11","bio11","WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of coldest quarter","mean T of coldest qtr","year","degrees Celsius","*degree*C*", +"bio12","bio12","WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual precipitation","ann. P","year","mm per year","*mm~yr^-1*", +"bio13","bio13","WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest month","P of wettest mo.","year","mm per month","*mm~mo^-1*", +"bio14","bio14","WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest month","P of driest mo.","year","mm per month","*mm~mo^-1*", +"bio15","bio15","WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation seasonality (coeff var)","P season.","year","","", +"bio16","bio16","WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest quarter","P of wettest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio17","bio17","WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest quarter","P of driest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio18","bio18","WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of warmest quarter","P of warmest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio19","bio19","WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of coldest quarter","P of coldest qtr","year","mm per quarter","*mm~qtr^-1*", +"precipitation_01","precipitation_01","WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jan","P Jan","january","mm per month","*mm~mo^-1*", +"precipitation_02","precipitation_02","WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Feb","P Feb","february","mm per month","*mm~mo^-1*", +"precipitation_03","precipitation_03","WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Mar","P Mar","march","mm per month","*mm~mo^-1*", +"precipitation_04","precipitation_04","WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Apr","P Apr","april","mm per month","*mm~mo^-1*", +"precipitation_05","precipitation_05","WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation May","P May","may","mm per month","*mm~mo^-1*", +"precipitation_06","precipitation_06","WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jun","P Jun","june","mm per month","*mm~mo^-1*", +"precipitation_07","precipitation_07","WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jul","P Jul","july","mm per month","*mm~mo^-1*", +"precipitation_08","precipitation_08","WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Aug","P Aug","august","mm per month","*mm~mo^-1*", +"precipitation_09","precipitation_09","WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Sep","P Sep","september","mm per month","*mm~mo^-1*", +"precipitation_10","precipitation_10","WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Oct","P Oct","october","mm per month","*mm~mo^-1*", +"precipitation_11","precipitation_11","WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Nov","P Nov","november","mm per month","*mm~mo^-1*", +"precipitation_12","precipitation_12","WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Dec","P Dec","december","mm per month","*mm~mo^-1*", +"temperature_min_01","temperature_min_01","WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jan","min T Jan","january","degrees Celsius","*degree*C*", +"temperature_min_02","temperature_min_02","WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Feb","min T Feb","february","degrees Celsius","*degree*C*", +"temperature_min_03","temperature_min_03","WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Mar","min T Mar","march","degrees Celsius","*degree*C*", +"temperature_min_04","temperature_min_04","WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Apr","min T Apr","april","degrees Celsius","*degree*C*", +"temperature_min_05","temperature_min_05","WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature May","min T May","may","degrees Celsius","*degree*C*", +"temperature_min_06","temperature_min_06","WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jun","min T Jun","june","degrees Celsius","*degree*C*", +"temperature_min_07","temperature_min_07","WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jul","min T Jul","july","degrees Celsius","*degree*C*", +"temperature_min_08","temperature_min_08","WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Aug","min T Aug","august","degrees Celsius","*degree*C*", +"temperature_min_09","temperature_min_09","WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Sep","min T Sep","september","degrees Celsius","*degree*C*", +"temperature_min_10","temperature_min_10","WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Oct","min T Oct","october","degrees Celsius","*degree*C*", +"temperature_min_11","temperature_min_11","WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Nov","min T Nov","november","degrees Celsius","*degree*C*", +"temperature_min_12","temperature_min_12","WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Dec","min T Dec","december","degrees Celsius","*degree*C*", +"temperature_max_01","temperature_max_01","WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jan","max T Jan","january","degrees Celsius","*degree*C*", +"temperature_max_02","temperature_max_02","WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Feb","max T Feb","february","degrees Celsius","*degree*C*", +"temperature_max_03","temperature_max_03","WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Mar","max T Mar","march","degrees Celsius","*degree*C*", +"temperature_max_04","temperature_max_04","WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Apr","max T Apr","april","degrees Celsius","*degree*C*", +"temperature_max_05","temperature_max_05","WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature May","max T May","may","degrees Celsius","*degree*C*", +"temperature_max_06","temperature_max_06","WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jun","max T Jun","june","degrees Celsius","*degree*C*", +"temperature_max_07","temperature_max_07","WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jul","max T Jul","july","degrees Celsius","*degree*C*", +"temperature_max_08","temperature_max_08","WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Aug","max T Aug","august","degrees Celsius","*degree*C*", +"temperature_max_09","temperature_max_09","WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Sep","max T Sep","september","degrees Celsius","*degree*C*", +"temperature_max_10","temperature_max_10","WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Oct","max T Oct","october","degrees Celsius","*degree*C*", +"temperature_max_11","temperature_max_11","WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Nov","max T Nov","november","degrees Celsius","*degree*C*", +"temperature_max_12","temperature_max_12","WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Dec","max T Dec","december","degrees Celsius","*degree*C*", +"bio01","bio01","WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual mean temperature","ann. mean T","year","degrees Celsius","*degree*C*", +"bio02","bio02","WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean diurnal range","diurn. range","year","degrees Celsius","*degree*C*", +"bio03","bio03","WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","isothermality","isothermality","year","","", +"bio04","bio04","WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature seasonality","T season.","year","degrees Celsius","*degree*C*", +"bio05","bio05","WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature of warmest month","max. T of warmest mo.","year","degrees Celsius","*degree*C*", +"bio06","bio06","WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature of coldest month","min. T of coldest mo.","year","degrees Celsius","*degree*C*", +"bio07","bio07","WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature annual range (bio05-bio06)","T ann. Range","year","degrees Celsius","*degree*C*", +"bio08","bio08","WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of wettest quarter","mean T of wettest qtr","year","degrees Celsius","*degree*C*", +"bio09","bio09","WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of driest quarter","mean T of driest qtr","year","degrees Celsius","*degree*C*", +"bio10","bio10","WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of warmest quarter","mean T of warmest qtr","year","degrees Celsius","*degree*C*", +"bio11","bio11","WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of coldest quarter","mean T of coldest qtr","year","degrees Celsius","*degree*C*", +"bio12","bio12","WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual precipitation","ann. P","year","mm per year","*mm~yr^-1*", +"bio13","bio13","WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest month","P of wettest mo.","year","mm per month","*mm~mo^-1*", +"bio14","bio14","WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest month","P of driest mo.","year","mm per month","*mm~mo^-1*", +"bio15","bio15","WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation seasonality (coeff var)","P season.","year","","", +"bio16","bio16","WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest quarter","P of wettest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio17","bio17","WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest quarter","P of driest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio18","bio18","WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of warmest quarter","P of warmest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio19","bio19","WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of coldest quarter","P of coldest qtr","year","mm per quarter","*mm~qtr^-1*", +"precipitation_01","precipitation_01","WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jan","P Jan","january","mm per month","*mm~mo^-1*", +"precipitation_02","precipitation_02","WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Feb","P Feb","february","mm per month","*mm~mo^-1*", +"precipitation_03","precipitation_03","WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Mar","P Mar","march","mm per month","*mm~mo^-1*", +"precipitation_04","precipitation_04","WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Apr","P Apr","april","mm per month","*mm~mo^-1*", +"precipitation_05","precipitation_05","WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation May","P May","may","mm per month","*mm~mo^-1*", +"precipitation_06","precipitation_06","WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jun","P Jun","june","mm per month","*mm~mo^-1*", +"precipitation_07","precipitation_07","WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jul","P Jul","july","mm per month","*mm~mo^-1*", +"precipitation_08","precipitation_08","WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Aug","P Aug","august","mm per month","*mm~mo^-1*", +"precipitation_09","precipitation_09","WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Sep","P Sep","september","mm per month","*mm~mo^-1*", +"precipitation_10","precipitation_10","WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Oct","P Oct","october","mm per month","*mm~mo^-1*", +"precipitation_11","precipitation_11","WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Nov","P Nov","november","mm per month","*mm~mo^-1*", +"precipitation_12","precipitation_12","WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Dec","P Dec","december","mm per month","*mm~mo^-1*", +"temperature_min_01","temperature_min_01","WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jan","min T Jan","january","degrees Celsius","*degree*C*", +"temperature_min_02","temperature_min_02","WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Feb","min T Feb","february","degrees Celsius","*degree*C*", +"temperature_min_03","temperature_min_03","WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Mar","min T Mar","march","degrees Celsius","*degree*C*", +"temperature_min_04","temperature_min_04","WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Apr","min T Apr","april","degrees Celsius","*degree*C*", +"temperature_min_05","temperature_min_05","WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature May","min T May","may","degrees Celsius","*degree*C*", +"temperature_min_06","temperature_min_06","WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jun","min T Jun","june","degrees Celsius","*degree*C*", +"temperature_min_07","temperature_min_07","WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jul","min T Jul","july","degrees Celsius","*degree*C*", +"temperature_min_08","temperature_min_08","WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Aug","min T Aug","august","degrees Celsius","*degree*C*", +"temperature_min_09","temperature_min_09","WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Sep","min T Sep","september","degrees Celsius","*degree*C*", +"temperature_min_10","temperature_min_10","WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Oct","min T Oct","october","degrees Celsius","*degree*C*", +"temperature_min_11","temperature_min_11","WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Nov","min T Nov","november","degrees Celsius","*degree*C*", +"temperature_min_12","temperature_min_12","WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Dec","min T Dec","december","degrees Celsius","*degree*C*", +"temperature_max_01","temperature_max_01","WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jan","max T Jan","january","degrees Celsius","*degree*C*", +"temperature_max_02","temperature_max_02","WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Feb","max T Feb","february","degrees Celsius","*degree*C*", +"temperature_max_03","temperature_max_03","WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Mar","max T Mar","march","degrees Celsius","*degree*C*", +"temperature_max_04","temperature_max_04","WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Apr","max T Apr","april","degrees Celsius","*degree*C*", +"temperature_max_05","temperature_max_05","WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature May","max T May","may","degrees Celsius","*degree*C*", +"temperature_max_06","temperature_max_06","WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jun","max T Jun","june","degrees Celsius","*degree*C*", +"temperature_max_07","temperature_max_07","WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jul","max T Jul","july","degrees Celsius","*degree*C*", +"temperature_max_08","temperature_max_08","WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Aug","max T Aug","august","degrees Celsius","*degree*C*", +"temperature_max_09","temperature_max_09","WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Sep","max T Sep","september","degrees Celsius","*degree*C*", +"temperature_max_10","temperature_max_10","WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Oct","max T Oct","october","degrees Celsius","*degree*C*", +"temperature_max_11","temperature_max_11","WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Nov","max T Nov","november","degrees Celsius","*degree*C*", +"temperature_max_12","temperature_max_12","WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Dec","max T Dec","december","degrees Celsius","*degree*C*", +"bio01","bio01","WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual mean temperature","ann. mean T","year","degrees Celsius","*degree*C*", +"bio02","bio02","WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean diurnal range","diurn. range","year","degrees Celsius","*degree*C*", +"bio03","bio03","WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","isothermality","isothermality","year","","", +"bio04","bio04","WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature seasonality","T season.","year","degrees Celsius","*degree*C*", +"bio05","bio05","WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature of warmest month","max. T of warmest mo.","year","degrees Celsius","*degree*C*", +"bio06","bio06","WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature of coldest month","min. T of coldest mo.","year","degrees Celsius","*degree*C*", +"bio07","bio07","WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature annual range (bio05-bio06)","T ann. Range","year","degrees Celsius","*degree*C*", +"bio08","bio08","WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of wettest quarter","mean T of wettest qtr","year","degrees Celsius","*degree*C*", +"bio09","bio09","WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of driest quarter","mean T of driest qtr","year","degrees Celsius","*degree*C*", +"bio10","bio10","WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of warmest quarter","mean T of warmest qtr","year","degrees Celsius","*degree*C*", +"bio11","bio11","WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of coldest quarter","mean T of coldest qtr","year","degrees Celsius","*degree*C*", +"bio12","bio12","WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual precipitation","ann. P","year","mm per year","*mm~yr^-1*", +"bio13","bio13","WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest month","P of wettest mo.","year","mm per month","*mm~mo^-1*", +"bio14","bio14","WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest month","P of driest mo.","year","mm per month","*mm~mo^-1*", +"bio15","bio15","WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation seasonality (coeff var)","P season.","year","","", +"bio16","bio16","WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest quarter","P of wettest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio17","bio17","WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest quarter","P of driest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio18","bio18","WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of warmest quarter","P of warmest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio19","bio19","WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of coldest quarter","P of coldest qtr","year","mm per quarter","*mm~qtr^-1*", +"precipitation_01","precipitation_01","WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jan","P Jan","january","mm per month","*mm~mo^-1*", +"precipitation_02","precipitation_02","WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Feb","P Feb","february","mm per month","*mm~mo^-1*", +"precipitation_03","precipitation_03","WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Mar","P Mar","march","mm per month","*mm~mo^-1*", +"precipitation_04","precipitation_04","WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Apr","P Apr","april","mm per month","*mm~mo^-1*", +"precipitation_05","precipitation_05","WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation May","P May","may","mm per month","*mm~mo^-1*", +"precipitation_06","precipitation_06","WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jun","P Jun","june","mm per month","*mm~mo^-1*", +"precipitation_07","precipitation_07","WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jul","P Jul","july","mm per month","*mm~mo^-1*", +"precipitation_08","precipitation_08","WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Aug","P Aug","august","mm per month","*mm~mo^-1*", +"precipitation_09","precipitation_09","WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Sep","P Sep","september","mm per month","*mm~mo^-1*", +"precipitation_10","precipitation_10","WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Oct","P Oct","october","mm per month","*mm~mo^-1*", +"precipitation_11","precipitation_11","WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Nov","P Nov","november","mm per month","*mm~mo^-1*", +"precipitation_12","precipitation_12","WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Dec","P Dec","december","mm per month","*mm~mo^-1*", +"temperature_min_01","temperature_min_01","WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jan","min T Jan","january","degrees Celsius","*degree*C*", +"temperature_min_02","temperature_min_02","WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Feb","min T Feb","february","degrees Celsius","*degree*C*", +"temperature_min_03","temperature_min_03","WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Mar","min T Mar","march","degrees Celsius","*degree*C*", +"temperature_min_04","temperature_min_04","WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Apr","min T Apr","april","degrees Celsius","*degree*C*", +"temperature_min_05","temperature_min_05","WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature May","min T May","may","degrees Celsius","*degree*C*", +"temperature_min_06","temperature_min_06","WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jun","min T Jun","june","degrees Celsius","*degree*C*", +"temperature_min_07","temperature_min_07","WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jul","min T Jul","july","degrees Celsius","*degree*C*", +"temperature_min_08","temperature_min_08","WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Aug","min T Aug","august","degrees Celsius","*degree*C*", +"temperature_min_09","temperature_min_09","WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Sep","min T Sep","september","degrees Celsius","*degree*C*", +"temperature_min_10","temperature_min_10","WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Oct","min T Oct","october","degrees Celsius","*degree*C*", +"temperature_min_11","temperature_min_11","WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Nov","min T Nov","november","degrees Celsius","*degree*C*", +"temperature_min_12","temperature_min_12","WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Dec","min T Dec","december","degrees Celsius","*degree*C*", +"temperature_max_01","temperature_max_01","WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jan","max T Jan","january","degrees Celsius","*degree*C*", +"temperature_max_02","temperature_max_02","WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Feb","max T Feb","february","degrees Celsius","*degree*C*", +"temperature_max_03","temperature_max_03","WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Mar","max T Mar","march","degrees Celsius","*degree*C*", +"temperature_max_04","temperature_max_04","WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Apr","max T Apr","april","degrees Celsius","*degree*C*", +"temperature_max_05","temperature_max_05","WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature May","max T May","may","degrees Celsius","*degree*C*", +"temperature_max_06","temperature_max_06","WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jun","max T Jun","june","degrees Celsius","*degree*C*", +"temperature_max_07","temperature_max_07","WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jul","max T Jul","july","degrees Celsius","*degree*C*", +"temperature_max_08","temperature_max_08","WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Aug","max T Aug","august","degrees Celsius","*degree*C*", +"temperature_max_09","temperature_max_09","WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Sep","max T Sep","september","degrees Celsius","*degree*C*", +"temperature_max_10","temperature_max_10","WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Oct","max T Oct","october","degrees Celsius","*degree*C*", +"temperature_max_11","temperature_max_11","WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Nov","max T Nov","november","degrees Celsius","*degree*C*", +"temperature_max_12","temperature_max_12","WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Dec","max T Dec","december","degrees Celsius","*degree*C*", +"bio01","bio01","WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual mean temperature","ann. mean T","year","degrees Celsius","*degree*C*", +"bio02","bio02","WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean diurnal range","diurn. range","year","degrees Celsius","*degree*C*", +"bio03","bio03","WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","isothermality","isothermality","year","","", +"bio04","bio04","WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature seasonality","T season.","year","degrees Celsius","*degree*C*", +"bio05","bio05","WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature of warmest month","max. T of warmest mo.","year","degrees Celsius","*degree*C*", +"bio06","bio06","WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature of coldest month","min. T of coldest mo.","year","degrees Celsius","*degree*C*", +"bio07","bio07","WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature annual range (bio05-bio06)","T ann. Range","year","degrees Celsius","*degree*C*", +"bio08","bio08","WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of wettest quarter","mean T of wettest qtr","year","degrees Celsius","*degree*C*", +"bio09","bio09","WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of driest quarter","mean T of driest qtr","year","degrees Celsius","*degree*C*", +"bio10","bio10","WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of warmest quarter","mean T of warmest qtr","year","degrees Celsius","*degree*C*", +"bio11","bio11","WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of coldest quarter","mean T of coldest qtr","year","degrees Celsius","*degree*C*", +"bio12","bio12","WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual precipitation","ann. P","year","mm per year","*mm~yr^-1*", +"bio13","bio13","WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest month","P of wettest mo.","year","mm per month","*mm~mo^-1*", +"bio14","bio14","WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest month","P of driest mo.","year","mm per month","*mm~mo^-1*", +"bio15","bio15","WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation seasonality (coeff var)","P season.","year","","", +"bio16","bio16","WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest quarter","P of wettest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio17","bio17","WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest quarter","P of driest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio18","bio18","WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of warmest quarter","P of warmest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio19","bio19","WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of coldest quarter","P of coldest qtr","year","mm per quarter","*mm~qtr^-1*", +"precipitation_01","precipitation_01","WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jan","P Jan","january","mm per month","*mm~mo^-1*", +"precipitation_02","precipitation_02","WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Feb","P Feb","february","mm per month","*mm~mo^-1*", +"precipitation_03","precipitation_03","WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Mar","P Mar","march","mm per month","*mm~mo^-1*", +"precipitation_04","precipitation_04","WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Apr","P Apr","april","mm per month","*mm~mo^-1*", +"precipitation_05","precipitation_05","WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation May","P May","may","mm per month","*mm~mo^-1*", +"precipitation_06","precipitation_06","WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jun","P Jun","june","mm per month","*mm~mo^-1*", +"precipitation_07","precipitation_07","WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jul","P Jul","july","mm per month","*mm~mo^-1*", +"precipitation_08","precipitation_08","WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Aug","P Aug","august","mm per month","*mm~mo^-1*", +"precipitation_09","precipitation_09","WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Sep","P Sep","september","mm per month","*mm~mo^-1*", +"precipitation_10","precipitation_10","WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Oct","P Oct","october","mm per month","*mm~mo^-1*", +"precipitation_11","precipitation_11","WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Nov","P Nov","november","mm per month","*mm~mo^-1*", +"precipitation_12","precipitation_12","WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Dec","P Dec","december","mm per month","*mm~mo^-1*", +"temperature_min_01","temperature_min_01","WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jan","min T Jan","january","degrees Celsius","*degree*C*", +"temperature_min_02","temperature_min_02","WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Feb","min T Feb","february","degrees Celsius","*degree*C*", +"temperature_min_03","temperature_min_03","WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Mar","min T Mar","march","degrees Celsius","*degree*C*", +"temperature_min_04","temperature_min_04","WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Apr","min T Apr","april","degrees Celsius","*degree*C*", +"temperature_min_05","temperature_min_05","WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature May","min T May","may","degrees Celsius","*degree*C*", +"temperature_min_06","temperature_min_06","WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jun","min T Jun","june","degrees Celsius","*degree*C*", +"temperature_min_07","temperature_min_07","WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jul","min T Jul","july","degrees Celsius","*degree*C*", +"temperature_min_08","temperature_min_08","WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Aug","min T Aug","august","degrees Celsius","*degree*C*", +"temperature_min_09","temperature_min_09","WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Sep","min T Sep","september","degrees Celsius","*degree*C*", +"temperature_min_10","temperature_min_10","WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Oct","min T Oct","october","degrees Celsius","*degree*C*", +"temperature_min_11","temperature_min_11","WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Nov","min T Nov","november","degrees Celsius","*degree*C*", +"temperature_min_12","temperature_min_12","WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Dec","min T Dec","december","degrees Celsius","*degree*C*", +"temperature_max_01","temperature_max_01","WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jan","max T Jan","january","degrees Celsius","*degree*C*", +"temperature_max_02","temperature_max_02","WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Feb","max T Feb","february","degrees Celsius","*degree*C*", +"temperature_max_03","temperature_max_03","WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Mar","max T Mar","march","degrees Celsius","*degree*C*", +"temperature_max_04","temperature_max_04","WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Apr","max T Apr","april","degrees Celsius","*degree*C*", +"temperature_max_05","temperature_max_05","WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature May","max T May","may","degrees Celsius","*degree*C*", +"temperature_max_06","temperature_max_06","WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jun","max T Jun","june","degrees Celsius","*degree*C*", +"temperature_max_07","temperature_max_07","WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jul","max T Jul","july","degrees Celsius","*degree*C*", +"temperature_max_08","temperature_max_08","WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Aug","max T Aug","august","degrees Celsius","*degree*C*", +"temperature_max_09","temperature_max_09","WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Sep","max T Sep","september","degrees Celsius","*degree*C*", +"temperature_max_10","temperature_max_10","WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Oct","max T Oct","october","degrees Celsius","*degree*C*", +"temperature_max_11","temperature_max_11","WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Nov","max T Nov","november","degrees Celsius","*degree*C*", +"temperature_max_12","temperature_max_12","WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Dec","max T Dec","december","degrees Celsius","*degree*C*", +"bio01","bio01","WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual mean temperature","ann. mean T","year","degrees Celsius","*degree*C*", +"bio02","bio02","WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean diurnal range","diurn. range","year","degrees Celsius","*degree*C*", +"bio03","bio03","WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","isothermality","isothermality","year","","", +"bio04","bio04","WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature seasonality","T season.","year","degrees Celsius","*degree*C*", +"bio05","bio05","WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature of warmest month","max. T of warmest mo.","year","degrees Celsius","*degree*C*", +"bio06","bio06","WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature of coldest month","min. T of coldest mo.","year","degrees Celsius","*degree*C*", +"bio07","bio07","WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature annual range (bio05-bio06)","T ann. Range","year","degrees Celsius","*degree*C*", +"bio08","bio08","WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of wettest quarter","mean T of wettest qtr","year","degrees Celsius","*degree*C*", +"bio09","bio09","WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of driest quarter","mean T of driest qtr","year","degrees Celsius","*degree*C*", +"bio10","bio10","WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of warmest quarter","mean T of warmest qtr","year","degrees Celsius","*degree*C*", +"bio11","bio11","WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of coldest quarter","mean T of coldest qtr","year","degrees Celsius","*degree*C*", +"bio12","bio12","WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual precipitation","ann. P","year","mm per year","*mm~yr^-1*", +"bio13","bio13","WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest month","P of wettest mo.","year","mm per month","*mm~mo^-1*", +"bio14","bio14","WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest month","P of driest mo.","year","mm per month","*mm~mo^-1*", +"bio15","bio15","WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation seasonality (coeff var)","P season.","year","","", +"bio16","bio16","WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest quarter","P of wettest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio17","bio17","WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest quarter","P of driest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio18","bio18","WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of warmest quarter","P of warmest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio19","bio19","WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of coldest quarter","P of coldest qtr","year","mm per quarter","*mm~qtr^-1*", +"precipitation_01","precipitation_01","WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jan","P Jan","january","mm per month","*mm~mo^-1*", +"precipitation_02","precipitation_02","WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Feb","P Feb","february","mm per month","*mm~mo^-1*", +"precipitation_03","precipitation_03","WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Mar","P Mar","march","mm per month","*mm~mo^-1*", +"precipitation_04","precipitation_04","WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Apr","P Apr","april","mm per month","*mm~mo^-1*", +"precipitation_05","precipitation_05","WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation May","P May","may","mm per month","*mm~mo^-1*", +"precipitation_06","precipitation_06","WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jun","P Jun","june","mm per month","*mm~mo^-1*", +"precipitation_07","precipitation_07","WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jul","P Jul","july","mm per month","*mm~mo^-1*", +"precipitation_08","precipitation_08","WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Aug","P Aug","august","mm per month","*mm~mo^-1*", +"precipitation_09","precipitation_09","WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Sep","P Sep","september","mm per month","*mm~mo^-1*", +"precipitation_10","precipitation_10","WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Oct","P Oct","october","mm per month","*mm~mo^-1*", +"precipitation_11","precipitation_11","WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Nov","P Nov","november","mm per month","*mm~mo^-1*", +"precipitation_12","precipitation_12","WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Dec","P Dec","december","mm per month","*mm~mo^-1*", +"temperature_min_01","temperature_min_01","WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jan","min T Jan","january","degrees Celsius","*degree*C*", +"temperature_min_02","temperature_min_02","WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Feb","min T Feb","february","degrees Celsius","*degree*C*", +"temperature_min_03","temperature_min_03","WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Mar","min T Mar","march","degrees Celsius","*degree*C*", +"temperature_min_04","temperature_min_04","WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Apr","min T Apr","april","degrees Celsius","*degree*C*", +"temperature_min_05","temperature_min_05","WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature May","min T May","may","degrees Celsius","*degree*C*", +"temperature_min_06","temperature_min_06","WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jun","min T Jun","june","degrees Celsius","*degree*C*", +"temperature_min_07","temperature_min_07","WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jul","min T Jul","july","degrees Celsius","*degree*C*", +"temperature_min_08","temperature_min_08","WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Aug","min T Aug","august","degrees Celsius","*degree*C*", +"temperature_min_09","temperature_min_09","WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Sep","min T Sep","september","degrees Celsius","*degree*C*", +"temperature_min_10","temperature_min_10","WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Oct","min T Oct","october","degrees Celsius","*degree*C*", +"temperature_min_11","temperature_min_11","WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Nov","min T Nov","november","degrees Celsius","*degree*C*", +"temperature_min_12","temperature_min_12","WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Dec","min T Dec","december","degrees Celsius","*degree*C*", +"temperature_max_01","temperature_max_01","WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jan","max T Jan","january","degrees Celsius","*degree*C*", +"temperature_max_02","temperature_max_02","WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Feb","max T Feb","february","degrees Celsius","*degree*C*", +"temperature_max_03","temperature_max_03","WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Mar","max T Mar","march","degrees Celsius","*degree*C*", +"temperature_max_04","temperature_max_04","WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Apr","max T Apr","april","degrees Celsius","*degree*C*", +"temperature_max_05","temperature_max_05","WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature May","max T May","may","degrees Celsius","*degree*C*", +"temperature_max_06","temperature_max_06","WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jun","max T Jun","june","degrees Celsius","*degree*C*", +"temperature_max_07","temperature_max_07","WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jul","max T Jul","july","degrees Celsius","*degree*C*", +"temperature_max_08","temperature_max_08","WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Aug","max T Aug","august","degrees Celsius","*degree*C*", +"temperature_max_09","temperature_max_09","WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Sep","max T Sep","september","degrees Celsius","*degree*C*", +"temperature_max_10","temperature_max_10","WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Oct","max T Oct","october","degrees Celsius","*degree*C*", +"temperature_max_11","temperature_max_11","WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Nov","max T Nov","november","degrees Celsius","*degree*C*", +"temperature_max_12","temperature_max_12","WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Dec","max T Dec","december","degrees Celsius","*degree*C*", +"bio01","bio01","WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual mean temperature","ann. mean T","year","degrees Celsius","*degree*C*", +"bio02","bio02","WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean diurnal range","diurn. range","year","degrees Celsius","*degree*C*", +"bio03","bio03","WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","isothermality","isothermality","year","","", +"bio04","bio04","WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature seasonality","T season.","year","degrees Celsius","*degree*C*", +"bio05","bio05","WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature of warmest month","max. T of warmest mo.","year","degrees Celsius","*degree*C*", +"bio06","bio06","WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature of coldest month","min. T of coldest mo.","year","degrees Celsius","*degree*C*", +"bio07","bio07","WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature annual range (bio05-bio06)","T ann. Range","year","degrees Celsius","*degree*C*", +"bio08","bio08","WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of wettest quarter","mean T of wettest qtr","year","degrees Celsius","*degree*C*", +"bio09","bio09","WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of driest quarter","mean T of driest qtr","year","degrees Celsius","*degree*C*", +"bio10","bio10","WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of warmest quarter","mean T of warmest qtr","year","degrees Celsius","*degree*C*", +"bio11","bio11","WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of coldest quarter","mean T of coldest qtr","year","degrees Celsius","*degree*C*", +"bio12","bio12","WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual precipitation","ann. P","year","mm per year","*mm~yr^-1*", +"bio13","bio13","WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest month","P of wettest mo.","year","mm per month","*mm~mo^-1*", +"bio14","bio14","WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest month","P of driest mo.","year","mm per month","*mm~mo^-1*", +"bio15","bio15","WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation seasonality (coeff var)","P season.","year","","", +"bio16","bio16","WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest quarter","P of wettest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio17","bio17","WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest quarter","P of driest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio18","bio18","WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of warmest quarter","P of warmest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio19","bio19","WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m",FALSE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of coldest quarter","P of coldest qtr","year","mm per quarter","*mm~qtr^-1*", +"precipitation_01","precipitation_01","WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jan","P Jan","january","mm per month","*mm~mo^-1*", +"precipitation_02","precipitation_02","WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Feb","P Feb","february","mm per month","*mm~mo^-1*", +"precipitation_03","precipitation_03","WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Mar","P Mar","march","mm per month","*mm~mo^-1*", +"precipitation_04","precipitation_04","WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Apr","P Apr","april","mm per month","*mm~mo^-1*", +"precipitation_05","precipitation_05","WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation May","P May","may","mm per month","*mm~mo^-1*", +"precipitation_06","precipitation_06","WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jun","P Jun","june","mm per month","*mm~mo^-1*", +"precipitation_07","precipitation_07","WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jul","P Jul","july","mm per month","*mm~mo^-1*", +"precipitation_08","precipitation_08","WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Aug","P Aug","august","mm per month","*mm~mo^-1*", +"precipitation_09","precipitation_09","WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Sep","P Sep","september","mm per month","*mm~mo^-1*", +"precipitation_10","precipitation_10","WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Oct","P Oct","october","mm per month","*mm~mo^-1*", +"precipitation_11","precipitation_11","WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Nov","P Nov","november","mm per month","*mm~mo^-1*", +"precipitation_12","precipitation_12","WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Dec","P Dec","december","mm per month","*mm~mo^-1*", +"temperature_min_01","temperature_min_01","WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jan","min T Jan","january","degrees Celsius","*degree*C*", +"temperature_min_02","temperature_min_02","WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Feb","min T Feb","february","degrees Celsius","*degree*C*", +"temperature_min_03","temperature_min_03","WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Mar","min T Mar","march","degrees Celsius","*degree*C*", +"temperature_min_04","temperature_min_04","WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Apr","min T Apr","april","degrees Celsius","*degree*C*", +"temperature_min_05","temperature_min_05","WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature May","min T May","may","degrees Celsius","*degree*C*", +"temperature_min_06","temperature_min_06","WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jun","min T Jun","june","degrees Celsius","*degree*C*", +"temperature_min_07","temperature_min_07","WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jul","min T Jul","july","degrees Celsius","*degree*C*", +"temperature_min_08","temperature_min_08","WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Aug","min T Aug","august","degrees Celsius","*degree*C*", +"temperature_min_09","temperature_min_09","WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Sep","min T Sep","september","degrees Celsius","*degree*C*", +"temperature_min_10","temperature_min_10","WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Oct","min T Oct","october","degrees Celsius","*degree*C*", +"temperature_min_11","temperature_min_11","WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Nov","min T Nov","november","degrees Celsius","*degree*C*", +"temperature_min_12","temperature_min_12","WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Dec","min T Dec","december","degrees Celsius","*degree*C*", +"temperature_max_01","temperature_max_01","WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jan","max T Jan","january","degrees Celsius","*degree*C*", +"temperature_max_02","temperature_max_02","WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Feb","max T Feb","february","degrees Celsius","*degree*C*", +"temperature_max_03","temperature_max_03","WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Mar","max T Mar","march","degrees Celsius","*degree*C*", +"temperature_max_04","temperature_max_04","WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Apr","max T Apr","april","degrees Celsius","*degree*C*", +"temperature_max_05","temperature_max_05","WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature May","max T May","may","degrees Celsius","*degree*C*", +"temperature_max_06","temperature_max_06","WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jun","max T Jun","june","degrees Celsius","*degree*C*", +"temperature_max_07","temperature_max_07","WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jul","max T Jul","july","degrees Celsius","*degree*C*", +"temperature_max_08","temperature_max_08","WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Aug","max T Aug","august","degrees Celsius","*degree*C*", +"temperature_max_09","temperature_max_09","WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Sep","max T Sep","september","degrees Celsius","*degree*C*", +"temperature_max_10","temperature_max_10","WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Oct","max T Oct","october","degrees Celsius","*degree*C*", +"temperature_max_11","temperature_max_11","WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Nov","max T Nov","november","degrees Celsius","*degree*C*", +"temperature_max_12","temperature_max_12","WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m",TRUE,"WorldClim_2.1_HadGEM3-GC31-LL_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Dec","max T Dec","december","degrees Celsius","*degree*C*", +"bio01","bio01","WorldClim_2.1_INM-CM5-0_ssp126_10m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual mean temperature","ann. mean T","year","degrees Celsius","*degree*C*", +"bio02","bio02","WorldClim_2.1_INM-CM5-0_ssp126_10m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean diurnal range","diurn. range","year","degrees Celsius","*degree*C*", +"bio03","bio03","WorldClim_2.1_INM-CM5-0_ssp126_10m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","isothermality","isothermality","year","","", +"bio04","bio04","WorldClim_2.1_INM-CM5-0_ssp126_10m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature seasonality","T season.","year","degrees Celsius","*degree*C*", +"bio05","bio05","WorldClim_2.1_INM-CM5-0_ssp126_10m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature of warmest month","max. T of warmest mo.","year","degrees Celsius","*degree*C*", +"bio06","bio06","WorldClim_2.1_INM-CM5-0_ssp126_10m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature of coldest month","min. T of coldest mo.","year","degrees Celsius","*degree*C*", +"bio07","bio07","WorldClim_2.1_INM-CM5-0_ssp126_10m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature annual range (bio05-bio06)","T ann. Range","year","degrees Celsius","*degree*C*", +"bio08","bio08","WorldClim_2.1_INM-CM5-0_ssp126_10m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of wettest quarter","mean T of wettest qtr","year","degrees Celsius","*degree*C*", +"bio09","bio09","WorldClim_2.1_INM-CM5-0_ssp126_10m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of driest quarter","mean T of driest qtr","year","degrees Celsius","*degree*C*", +"bio10","bio10","WorldClim_2.1_INM-CM5-0_ssp126_10m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of warmest quarter","mean T of warmest qtr","year","degrees Celsius","*degree*C*", +"bio11","bio11","WorldClim_2.1_INM-CM5-0_ssp126_10m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of coldest quarter","mean T of coldest qtr","year","degrees Celsius","*degree*C*", +"bio12","bio12","WorldClim_2.1_INM-CM5-0_ssp126_10m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual precipitation","ann. P","year","mm per year","*mm~yr^-1*", +"bio13","bio13","WorldClim_2.1_INM-CM5-0_ssp126_10m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest month","P of wettest mo.","year","mm per month","*mm~mo^-1*", +"bio14","bio14","WorldClim_2.1_INM-CM5-0_ssp126_10m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest month","P of driest mo.","year","mm per month","*mm~mo^-1*", +"bio15","bio15","WorldClim_2.1_INM-CM5-0_ssp126_10m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation seasonality (coeff var)","P season.","year","","", +"bio16","bio16","WorldClim_2.1_INM-CM5-0_ssp126_10m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest quarter","P of wettest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio17","bio17","WorldClim_2.1_INM-CM5-0_ssp126_10m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest quarter","P of driest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio18","bio18","WorldClim_2.1_INM-CM5-0_ssp126_10m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of warmest quarter","P of warmest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio19","bio19","WorldClim_2.1_INM-CM5-0_ssp126_10m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of coldest quarter","P of coldest qtr","year","mm per quarter","*mm~qtr^-1*", +"precipitation_01","precipitation_01","WorldClim_2.1_INM-CM5-0_ssp126_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jan","P Jan","january","mm per month","*mm~mo^-1*", +"precipitation_02","precipitation_02","WorldClim_2.1_INM-CM5-0_ssp126_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Feb","P Feb","february","mm per month","*mm~mo^-1*", +"precipitation_03","precipitation_03","WorldClim_2.1_INM-CM5-0_ssp126_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Mar","P Mar","march","mm per month","*mm~mo^-1*", +"precipitation_04","precipitation_04","WorldClim_2.1_INM-CM5-0_ssp126_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Apr","P Apr","april","mm per month","*mm~mo^-1*", +"precipitation_05","precipitation_05","WorldClim_2.1_INM-CM5-0_ssp126_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation May","P May","may","mm per month","*mm~mo^-1*", +"precipitation_06","precipitation_06","WorldClim_2.1_INM-CM5-0_ssp126_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jun","P Jun","june","mm per month","*mm~mo^-1*", +"precipitation_07","precipitation_07","WorldClim_2.1_INM-CM5-0_ssp126_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jul","P Jul","july","mm per month","*mm~mo^-1*", +"precipitation_08","precipitation_08","WorldClim_2.1_INM-CM5-0_ssp126_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Aug","P Aug","august","mm per month","*mm~mo^-1*", +"precipitation_09","precipitation_09","WorldClim_2.1_INM-CM5-0_ssp126_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Sep","P Sep","september","mm per month","*mm~mo^-1*", +"precipitation_10","precipitation_10","WorldClim_2.1_INM-CM5-0_ssp126_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Oct","P Oct","october","mm per month","*mm~mo^-1*", +"precipitation_11","precipitation_11","WorldClim_2.1_INM-CM5-0_ssp126_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Nov","P Nov","november","mm per month","*mm~mo^-1*", +"precipitation_12","precipitation_12","WorldClim_2.1_INM-CM5-0_ssp126_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Dec","P Dec","december","mm per month","*mm~mo^-1*", +"temperature_min_01","temperature_min_01","WorldClim_2.1_INM-CM5-0_ssp126_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jan","min T Jan","january","degrees Celsius","*degree*C*", +"temperature_min_02","temperature_min_02","WorldClim_2.1_INM-CM5-0_ssp126_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Feb","min T Feb","february","degrees Celsius","*degree*C*", +"temperature_min_03","temperature_min_03","WorldClim_2.1_INM-CM5-0_ssp126_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Mar","min T Mar","march","degrees Celsius","*degree*C*", +"temperature_min_04","temperature_min_04","WorldClim_2.1_INM-CM5-0_ssp126_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Apr","min T Apr","april","degrees Celsius","*degree*C*", +"temperature_min_05","temperature_min_05","WorldClim_2.1_INM-CM5-0_ssp126_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature May","min T May","may","degrees Celsius","*degree*C*", +"temperature_min_06","temperature_min_06","WorldClim_2.1_INM-CM5-0_ssp126_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jun","min T Jun","june","degrees Celsius","*degree*C*", +"temperature_min_07","temperature_min_07","WorldClim_2.1_INM-CM5-0_ssp126_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jul","min T Jul","july","degrees Celsius","*degree*C*", +"temperature_min_08","temperature_min_08","WorldClim_2.1_INM-CM5-0_ssp126_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Aug","min T Aug","august","degrees Celsius","*degree*C*", +"temperature_min_09","temperature_min_09","WorldClim_2.1_INM-CM5-0_ssp126_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Sep","min T Sep","september","degrees Celsius","*degree*C*", +"temperature_min_10","temperature_min_10","WorldClim_2.1_INM-CM5-0_ssp126_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Oct","min T Oct","october","degrees Celsius","*degree*C*", +"temperature_min_11","temperature_min_11","WorldClim_2.1_INM-CM5-0_ssp126_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Nov","min T Nov","november","degrees Celsius","*degree*C*", +"temperature_min_12","temperature_min_12","WorldClim_2.1_INM-CM5-0_ssp126_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Dec","min T Dec","december","degrees Celsius","*degree*C*", +"temperature_max_01","temperature_max_01","WorldClim_2.1_INM-CM5-0_ssp126_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jan","max T Jan","january","degrees Celsius","*degree*C*", +"temperature_max_02","temperature_max_02","WorldClim_2.1_INM-CM5-0_ssp126_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Feb","max T Feb","february","degrees Celsius","*degree*C*", +"temperature_max_03","temperature_max_03","WorldClim_2.1_INM-CM5-0_ssp126_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Mar","max T Mar","march","degrees Celsius","*degree*C*", +"temperature_max_04","temperature_max_04","WorldClim_2.1_INM-CM5-0_ssp126_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Apr","max T Apr","april","degrees Celsius","*degree*C*", +"temperature_max_05","temperature_max_05","WorldClim_2.1_INM-CM5-0_ssp126_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature May","max T May","may","degrees Celsius","*degree*C*", +"temperature_max_06","temperature_max_06","WorldClim_2.1_INM-CM5-0_ssp126_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jun","max T Jun","june","degrees Celsius","*degree*C*", +"temperature_max_07","temperature_max_07","WorldClim_2.1_INM-CM5-0_ssp126_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jul","max T Jul","july","degrees Celsius","*degree*C*", +"temperature_max_08","temperature_max_08","WorldClim_2.1_INM-CM5-0_ssp126_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Aug","max T Aug","august","degrees Celsius","*degree*C*", +"temperature_max_09","temperature_max_09","WorldClim_2.1_INM-CM5-0_ssp126_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Sep","max T Sep","september","degrees Celsius","*degree*C*", +"temperature_max_10","temperature_max_10","WorldClim_2.1_INM-CM5-0_ssp126_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Oct","max T Oct","october","degrees Celsius","*degree*C*", +"temperature_max_11","temperature_max_11","WorldClim_2.1_INM-CM5-0_ssp126_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Nov","max T Nov","november","degrees Celsius","*degree*C*", +"temperature_max_12","temperature_max_12","WorldClim_2.1_INM-CM5-0_ssp126_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Dec","max T Dec","december","degrees Celsius","*degree*C*", +"bio01","bio01","WorldClim_2.1_INM-CM5-0_ssp126_5m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual mean temperature","ann. mean T","year","degrees Celsius","*degree*C*", +"bio02","bio02","WorldClim_2.1_INM-CM5-0_ssp126_5m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean diurnal range","diurn. range","year","degrees Celsius","*degree*C*", +"bio03","bio03","WorldClim_2.1_INM-CM5-0_ssp126_5m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","isothermality","isothermality","year","","", +"bio04","bio04","WorldClim_2.1_INM-CM5-0_ssp126_5m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature seasonality","T season.","year","degrees Celsius","*degree*C*", +"bio05","bio05","WorldClim_2.1_INM-CM5-0_ssp126_5m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature of warmest month","max. T of warmest mo.","year","degrees Celsius","*degree*C*", +"bio06","bio06","WorldClim_2.1_INM-CM5-0_ssp126_5m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature of coldest month","min. T of coldest mo.","year","degrees Celsius","*degree*C*", +"bio07","bio07","WorldClim_2.1_INM-CM5-0_ssp126_5m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature annual range (bio05-bio06)","T ann. Range","year","degrees Celsius","*degree*C*", +"bio08","bio08","WorldClim_2.1_INM-CM5-0_ssp126_5m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of wettest quarter","mean T of wettest qtr","year","degrees Celsius","*degree*C*", +"bio09","bio09","WorldClim_2.1_INM-CM5-0_ssp126_5m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of driest quarter","mean T of driest qtr","year","degrees Celsius","*degree*C*", +"bio10","bio10","WorldClim_2.1_INM-CM5-0_ssp126_5m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of warmest quarter","mean T of warmest qtr","year","degrees Celsius","*degree*C*", +"bio11","bio11","WorldClim_2.1_INM-CM5-0_ssp126_5m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of coldest quarter","mean T of coldest qtr","year","degrees Celsius","*degree*C*", +"bio12","bio12","WorldClim_2.1_INM-CM5-0_ssp126_5m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual precipitation","ann. P","year","mm per year","*mm~yr^-1*", +"bio13","bio13","WorldClim_2.1_INM-CM5-0_ssp126_5m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest month","P of wettest mo.","year","mm per month","*mm~mo^-1*", +"bio14","bio14","WorldClim_2.1_INM-CM5-0_ssp126_5m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest month","P of driest mo.","year","mm per month","*mm~mo^-1*", +"bio15","bio15","WorldClim_2.1_INM-CM5-0_ssp126_5m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation seasonality (coeff var)","P season.","year","","", +"bio16","bio16","WorldClim_2.1_INM-CM5-0_ssp126_5m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest quarter","P of wettest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio17","bio17","WorldClim_2.1_INM-CM5-0_ssp126_5m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest quarter","P of driest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio18","bio18","WorldClim_2.1_INM-CM5-0_ssp126_5m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of warmest quarter","P of warmest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio19","bio19","WorldClim_2.1_INM-CM5-0_ssp126_5m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of coldest quarter","P of coldest qtr","year","mm per quarter","*mm~qtr^-1*", +"precipitation_01","precipitation_01","WorldClim_2.1_INM-CM5-0_ssp126_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jan","P Jan","january","mm per month","*mm~mo^-1*", +"precipitation_02","precipitation_02","WorldClim_2.1_INM-CM5-0_ssp126_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Feb","P Feb","february","mm per month","*mm~mo^-1*", +"precipitation_03","precipitation_03","WorldClim_2.1_INM-CM5-0_ssp126_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Mar","P Mar","march","mm per month","*mm~mo^-1*", +"precipitation_04","precipitation_04","WorldClim_2.1_INM-CM5-0_ssp126_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Apr","P Apr","april","mm per month","*mm~mo^-1*", +"precipitation_05","precipitation_05","WorldClim_2.1_INM-CM5-0_ssp126_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation May","P May","may","mm per month","*mm~mo^-1*", +"precipitation_06","precipitation_06","WorldClim_2.1_INM-CM5-0_ssp126_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jun","P Jun","june","mm per month","*mm~mo^-1*", +"precipitation_07","precipitation_07","WorldClim_2.1_INM-CM5-0_ssp126_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jul","P Jul","july","mm per month","*mm~mo^-1*", +"precipitation_08","precipitation_08","WorldClim_2.1_INM-CM5-0_ssp126_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Aug","P Aug","august","mm per month","*mm~mo^-1*", +"precipitation_09","precipitation_09","WorldClim_2.1_INM-CM5-0_ssp126_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Sep","P Sep","september","mm per month","*mm~mo^-1*", +"precipitation_10","precipitation_10","WorldClim_2.1_INM-CM5-0_ssp126_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Oct","P Oct","october","mm per month","*mm~mo^-1*", +"precipitation_11","precipitation_11","WorldClim_2.1_INM-CM5-0_ssp126_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Nov","P Nov","november","mm per month","*mm~mo^-1*", +"precipitation_12","precipitation_12","WorldClim_2.1_INM-CM5-0_ssp126_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Dec","P Dec","december","mm per month","*mm~mo^-1*", +"temperature_min_01","temperature_min_01","WorldClim_2.1_INM-CM5-0_ssp126_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jan","min T Jan","january","degrees Celsius","*degree*C*", +"temperature_min_02","temperature_min_02","WorldClim_2.1_INM-CM5-0_ssp126_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Feb","min T Feb","february","degrees Celsius","*degree*C*", +"temperature_min_03","temperature_min_03","WorldClim_2.1_INM-CM5-0_ssp126_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Mar","min T Mar","march","degrees Celsius","*degree*C*", +"temperature_min_04","temperature_min_04","WorldClim_2.1_INM-CM5-0_ssp126_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Apr","min T Apr","april","degrees Celsius","*degree*C*", +"temperature_min_05","temperature_min_05","WorldClim_2.1_INM-CM5-0_ssp126_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature May","min T May","may","degrees Celsius","*degree*C*", +"temperature_min_06","temperature_min_06","WorldClim_2.1_INM-CM5-0_ssp126_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jun","min T Jun","june","degrees Celsius","*degree*C*", +"temperature_min_07","temperature_min_07","WorldClim_2.1_INM-CM5-0_ssp126_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jul","min T Jul","july","degrees Celsius","*degree*C*", +"temperature_min_08","temperature_min_08","WorldClim_2.1_INM-CM5-0_ssp126_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Aug","min T Aug","august","degrees Celsius","*degree*C*", +"temperature_min_09","temperature_min_09","WorldClim_2.1_INM-CM5-0_ssp126_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Sep","min T Sep","september","degrees Celsius","*degree*C*", +"temperature_min_10","temperature_min_10","WorldClim_2.1_INM-CM5-0_ssp126_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Oct","min T Oct","october","degrees Celsius","*degree*C*", +"temperature_min_11","temperature_min_11","WorldClim_2.1_INM-CM5-0_ssp126_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Nov","min T Nov","november","degrees Celsius","*degree*C*", +"temperature_min_12","temperature_min_12","WorldClim_2.1_INM-CM5-0_ssp126_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Dec","min T Dec","december","degrees Celsius","*degree*C*", +"temperature_max_01","temperature_max_01","WorldClim_2.1_INM-CM5-0_ssp126_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jan","max T Jan","january","degrees Celsius","*degree*C*", +"temperature_max_02","temperature_max_02","WorldClim_2.1_INM-CM5-0_ssp126_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Feb","max T Feb","february","degrees Celsius","*degree*C*", +"temperature_max_03","temperature_max_03","WorldClim_2.1_INM-CM5-0_ssp126_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Mar","max T Mar","march","degrees Celsius","*degree*C*", +"temperature_max_04","temperature_max_04","WorldClim_2.1_INM-CM5-0_ssp126_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Apr","max T Apr","april","degrees Celsius","*degree*C*", +"temperature_max_05","temperature_max_05","WorldClim_2.1_INM-CM5-0_ssp126_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature May","max T May","may","degrees Celsius","*degree*C*", +"temperature_max_06","temperature_max_06","WorldClim_2.1_INM-CM5-0_ssp126_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jun","max T Jun","june","degrees Celsius","*degree*C*", +"temperature_max_07","temperature_max_07","WorldClim_2.1_INM-CM5-0_ssp126_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jul","max T Jul","july","degrees Celsius","*degree*C*", +"temperature_max_08","temperature_max_08","WorldClim_2.1_INM-CM5-0_ssp126_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Aug","max T Aug","august","degrees Celsius","*degree*C*", +"temperature_max_09","temperature_max_09","WorldClim_2.1_INM-CM5-0_ssp126_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Sep","max T Sep","september","degrees Celsius","*degree*C*", +"temperature_max_10","temperature_max_10","WorldClim_2.1_INM-CM5-0_ssp126_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Oct","max T Oct","october","degrees Celsius","*degree*C*", +"temperature_max_11","temperature_max_11","WorldClim_2.1_INM-CM5-0_ssp126_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Nov","max T Nov","november","degrees Celsius","*degree*C*", +"temperature_max_12","temperature_max_12","WorldClim_2.1_INM-CM5-0_ssp126_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Dec","max T Dec","december","degrees Celsius","*degree*C*", +"bio01","bio01","WorldClim_2.1_INM-CM5-0_ssp245_10m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual mean temperature","ann. mean T","year","degrees Celsius","*degree*C*", +"bio02","bio02","WorldClim_2.1_INM-CM5-0_ssp245_10m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean diurnal range","diurn. range","year","degrees Celsius","*degree*C*", +"bio03","bio03","WorldClim_2.1_INM-CM5-0_ssp245_10m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","isothermality","isothermality","year","","", +"bio04","bio04","WorldClim_2.1_INM-CM5-0_ssp245_10m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature seasonality","T season.","year","degrees Celsius","*degree*C*", +"bio05","bio05","WorldClim_2.1_INM-CM5-0_ssp245_10m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature of warmest month","max. T of warmest mo.","year","degrees Celsius","*degree*C*", +"bio06","bio06","WorldClim_2.1_INM-CM5-0_ssp245_10m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature of coldest month","min. T of coldest mo.","year","degrees Celsius","*degree*C*", +"bio07","bio07","WorldClim_2.1_INM-CM5-0_ssp245_10m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature annual range (bio05-bio06)","T ann. Range","year","degrees Celsius","*degree*C*", +"bio08","bio08","WorldClim_2.1_INM-CM5-0_ssp245_10m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of wettest quarter","mean T of wettest qtr","year","degrees Celsius","*degree*C*", +"bio09","bio09","WorldClim_2.1_INM-CM5-0_ssp245_10m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of driest quarter","mean T of driest qtr","year","degrees Celsius","*degree*C*", +"bio10","bio10","WorldClim_2.1_INM-CM5-0_ssp245_10m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of warmest quarter","mean T of warmest qtr","year","degrees Celsius","*degree*C*", +"bio11","bio11","WorldClim_2.1_INM-CM5-0_ssp245_10m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of coldest quarter","mean T of coldest qtr","year","degrees Celsius","*degree*C*", +"bio12","bio12","WorldClim_2.1_INM-CM5-0_ssp245_10m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual precipitation","ann. P","year","mm per year","*mm~yr^-1*", +"bio13","bio13","WorldClim_2.1_INM-CM5-0_ssp245_10m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest month","P of wettest mo.","year","mm per month","*mm~mo^-1*", +"bio14","bio14","WorldClim_2.1_INM-CM5-0_ssp245_10m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest month","P of driest mo.","year","mm per month","*mm~mo^-1*", +"bio15","bio15","WorldClim_2.1_INM-CM5-0_ssp245_10m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation seasonality (coeff var)","P season.","year","","", +"bio16","bio16","WorldClim_2.1_INM-CM5-0_ssp245_10m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest quarter","P of wettest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio17","bio17","WorldClim_2.1_INM-CM5-0_ssp245_10m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest quarter","P of driest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio18","bio18","WorldClim_2.1_INM-CM5-0_ssp245_10m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of warmest quarter","P of warmest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio19","bio19","WorldClim_2.1_INM-CM5-0_ssp245_10m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of coldest quarter","P of coldest qtr","year","mm per quarter","*mm~qtr^-1*", +"precipitation_01","precipitation_01","WorldClim_2.1_INM-CM5-0_ssp245_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jan","P Jan","january","mm per month","*mm~mo^-1*", +"precipitation_02","precipitation_02","WorldClim_2.1_INM-CM5-0_ssp245_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Feb","P Feb","february","mm per month","*mm~mo^-1*", +"precipitation_03","precipitation_03","WorldClim_2.1_INM-CM5-0_ssp245_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Mar","P Mar","march","mm per month","*mm~mo^-1*", +"precipitation_04","precipitation_04","WorldClim_2.1_INM-CM5-0_ssp245_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Apr","P Apr","april","mm per month","*mm~mo^-1*", +"precipitation_05","precipitation_05","WorldClim_2.1_INM-CM5-0_ssp245_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation May","P May","may","mm per month","*mm~mo^-1*", +"precipitation_06","precipitation_06","WorldClim_2.1_INM-CM5-0_ssp245_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jun","P Jun","june","mm per month","*mm~mo^-1*", +"precipitation_07","precipitation_07","WorldClim_2.1_INM-CM5-0_ssp245_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jul","P Jul","july","mm per month","*mm~mo^-1*", +"precipitation_08","precipitation_08","WorldClim_2.1_INM-CM5-0_ssp245_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Aug","P Aug","august","mm per month","*mm~mo^-1*", +"precipitation_09","precipitation_09","WorldClim_2.1_INM-CM5-0_ssp245_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Sep","P Sep","september","mm per month","*mm~mo^-1*", +"precipitation_10","precipitation_10","WorldClim_2.1_INM-CM5-0_ssp245_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Oct","P Oct","october","mm per month","*mm~mo^-1*", +"precipitation_11","precipitation_11","WorldClim_2.1_INM-CM5-0_ssp245_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Nov","P Nov","november","mm per month","*mm~mo^-1*", +"precipitation_12","precipitation_12","WorldClim_2.1_INM-CM5-0_ssp245_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Dec","P Dec","december","mm per month","*mm~mo^-1*", +"temperature_min_01","temperature_min_01","WorldClim_2.1_INM-CM5-0_ssp245_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jan","min T Jan","january","degrees Celsius","*degree*C*", +"temperature_min_02","temperature_min_02","WorldClim_2.1_INM-CM5-0_ssp245_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Feb","min T Feb","february","degrees Celsius","*degree*C*", +"temperature_min_03","temperature_min_03","WorldClim_2.1_INM-CM5-0_ssp245_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Mar","min T Mar","march","degrees Celsius","*degree*C*", +"temperature_min_04","temperature_min_04","WorldClim_2.1_INM-CM5-0_ssp245_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Apr","min T Apr","april","degrees Celsius","*degree*C*", +"temperature_min_05","temperature_min_05","WorldClim_2.1_INM-CM5-0_ssp245_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature May","min T May","may","degrees Celsius","*degree*C*", +"temperature_min_06","temperature_min_06","WorldClim_2.1_INM-CM5-0_ssp245_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jun","min T Jun","june","degrees Celsius","*degree*C*", +"temperature_min_07","temperature_min_07","WorldClim_2.1_INM-CM5-0_ssp245_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jul","min T Jul","july","degrees Celsius","*degree*C*", +"temperature_min_08","temperature_min_08","WorldClim_2.1_INM-CM5-0_ssp245_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Aug","min T Aug","august","degrees Celsius","*degree*C*", +"temperature_min_09","temperature_min_09","WorldClim_2.1_INM-CM5-0_ssp245_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Sep","min T Sep","september","degrees Celsius","*degree*C*", +"temperature_min_10","temperature_min_10","WorldClim_2.1_INM-CM5-0_ssp245_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Oct","min T Oct","october","degrees Celsius","*degree*C*", +"temperature_min_11","temperature_min_11","WorldClim_2.1_INM-CM5-0_ssp245_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Nov","min T Nov","november","degrees Celsius","*degree*C*", +"temperature_min_12","temperature_min_12","WorldClim_2.1_INM-CM5-0_ssp245_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Dec","min T Dec","december","degrees Celsius","*degree*C*", +"temperature_max_01","temperature_max_01","WorldClim_2.1_INM-CM5-0_ssp245_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jan","max T Jan","january","degrees Celsius","*degree*C*", +"temperature_max_02","temperature_max_02","WorldClim_2.1_INM-CM5-0_ssp245_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Feb","max T Feb","february","degrees Celsius","*degree*C*", +"temperature_max_03","temperature_max_03","WorldClim_2.1_INM-CM5-0_ssp245_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Mar","max T Mar","march","degrees Celsius","*degree*C*", +"temperature_max_04","temperature_max_04","WorldClim_2.1_INM-CM5-0_ssp245_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Apr","max T Apr","april","degrees Celsius","*degree*C*", +"temperature_max_05","temperature_max_05","WorldClim_2.1_INM-CM5-0_ssp245_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature May","max T May","may","degrees Celsius","*degree*C*", +"temperature_max_06","temperature_max_06","WorldClim_2.1_INM-CM5-0_ssp245_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jun","max T Jun","june","degrees Celsius","*degree*C*", +"temperature_max_07","temperature_max_07","WorldClim_2.1_INM-CM5-0_ssp245_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jul","max T Jul","july","degrees Celsius","*degree*C*", +"temperature_max_08","temperature_max_08","WorldClim_2.1_INM-CM5-0_ssp245_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Aug","max T Aug","august","degrees Celsius","*degree*C*", +"temperature_max_09","temperature_max_09","WorldClim_2.1_INM-CM5-0_ssp245_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Sep","max T Sep","september","degrees Celsius","*degree*C*", +"temperature_max_10","temperature_max_10","WorldClim_2.1_INM-CM5-0_ssp245_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Oct","max T Oct","october","degrees Celsius","*degree*C*", +"temperature_max_11","temperature_max_11","WorldClim_2.1_INM-CM5-0_ssp245_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Nov","max T Nov","november","degrees Celsius","*degree*C*", +"temperature_max_12","temperature_max_12","WorldClim_2.1_INM-CM5-0_ssp245_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Dec","max T Dec","december","degrees Celsius","*degree*C*", +"bio01","bio01","WorldClim_2.1_INM-CM5-0_ssp245_5m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual mean temperature","ann. mean T","year","degrees Celsius","*degree*C*", +"bio02","bio02","WorldClim_2.1_INM-CM5-0_ssp245_5m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean diurnal range","diurn. range","year","degrees Celsius","*degree*C*", +"bio03","bio03","WorldClim_2.1_INM-CM5-0_ssp245_5m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","isothermality","isothermality","year","","", +"bio04","bio04","WorldClim_2.1_INM-CM5-0_ssp245_5m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature seasonality","T season.","year","degrees Celsius","*degree*C*", +"bio05","bio05","WorldClim_2.1_INM-CM5-0_ssp245_5m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature of warmest month","max. T of warmest mo.","year","degrees Celsius","*degree*C*", +"bio06","bio06","WorldClim_2.1_INM-CM5-0_ssp245_5m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature of coldest month","min. T of coldest mo.","year","degrees Celsius","*degree*C*", +"bio07","bio07","WorldClim_2.1_INM-CM5-0_ssp245_5m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature annual range (bio05-bio06)","T ann. Range","year","degrees Celsius","*degree*C*", +"bio08","bio08","WorldClim_2.1_INM-CM5-0_ssp245_5m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of wettest quarter","mean T of wettest qtr","year","degrees Celsius","*degree*C*", +"bio09","bio09","WorldClim_2.1_INM-CM5-0_ssp245_5m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of driest quarter","mean T of driest qtr","year","degrees Celsius","*degree*C*", +"bio10","bio10","WorldClim_2.1_INM-CM5-0_ssp245_5m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of warmest quarter","mean T of warmest qtr","year","degrees Celsius","*degree*C*", +"bio11","bio11","WorldClim_2.1_INM-CM5-0_ssp245_5m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of coldest quarter","mean T of coldest qtr","year","degrees Celsius","*degree*C*", +"bio12","bio12","WorldClim_2.1_INM-CM5-0_ssp245_5m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual precipitation","ann. P","year","mm per year","*mm~yr^-1*", +"bio13","bio13","WorldClim_2.1_INM-CM5-0_ssp245_5m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest month","P of wettest mo.","year","mm per month","*mm~mo^-1*", +"bio14","bio14","WorldClim_2.1_INM-CM5-0_ssp245_5m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest month","P of driest mo.","year","mm per month","*mm~mo^-1*", +"bio15","bio15","WorldClim_2.1_INM-CM5-0_ssp245_5m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation seasonality (coeff var)","P season.","year","","", +"bio16","bio16","WorldClim_2.1_INM-CM5-0_ssp245_5m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest quarter","P of wettest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio17","bio17","WorldClim_2.1_INM-CM5-0_ssp245_5m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest quarter","P of driest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio18","bio18","WorldClim_2.1_INM-CM5-0_ssp245_5m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of warmest quarter","P of warmest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio19","bio19","WorldClim_2.1_INM-CM5-0_ssp245_5m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of coldest quarter","P of coldest qtr","year","mm per quarter","*mm~qtr^-1*", +"precipitation_01","precipitation_01","WorldClim_2.1_INM-CM5-0_ssp245_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jan","P Jan","january","mm per month","*mm~mo^-1*", +"precipitation_02","precipitation_02","WorldClim_2.1_INM-CM5-0_ssp245_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Feb","P Feb","february","mm per month","*mm~mo^-1*", +"precipitation_03","precipitation_03","WorldClim_2.1_INM-CM5-0_ssp245_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Mar","P Mar","march","mm per month","*mm~mo^-1*", +"precipitation_04","precipitation_04","WorldClim_2.1_INM-CM5-0_ssp245_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Apr","P Apr","april","mm per month","*mm~mo^-1*", +"precipitation_05","precipitation_05","WorldClim_2.1_INM-CM5-0_ssp245_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation May","P May","may","mm per month","*mm~mo^-1*", +"precipitation_06","precipitation_06","WorldClim_2.1_INM-CM5-0_ssp245_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jun","P Jun","june","mm per month","*mm~mo^-1*", +"precipitation_07","precipitation_07","WorldClim_2.1_INM-CM5-0_ssp245_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jul","P Jul","july","mm per month","*mm~mo^-1*", +"precipitation_08","precipitation_08","WorldClim_2.1_INM-CM5-0_ssp245_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Aug","P Aug","august","mm per month","*mm~mo^-1*", +"precipitation_09","precipitation_09","WorldClim_2.1_INM-CM5-0_ssp245_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Sep","P Sep","september","mm per month","*mm~mo^-1*", +"precipitation_10","precipitation_10","WorldClim_2.1_INM-CM5-0_ssp245_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Oct","P Oct","october","mm per month","*mm~mo^-1*", +"precipitation_11","precipitation_11","WorldClim_2.1_INM-CM5-0_ssp245_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Nov","P Nov","november","mm per month","*mm~mo^-1*", +"precipitation_12","precipitation_12","WorldClim_2.1_INM-CM5-0_ssp245_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Dec","P Dec","december","mm per month","*mm~mo^-1*", +"temperature_min_01","temperature_min_01","WorldClim_2.1_INM-CM5-0_ssp245_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jan","min T Jan","january","degrees Celsius","*degree*C*", +"temperature_min_02","temperature_min_02","WorldClim_2.1_INM-CM5-0_ssp245_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Feb","min T Feb","february","degrees Celsius","*degree*C*", +"temperature_min_03","temperature_min_03","WorldClim_2.1_INM-CM5-0_ssp245_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Mar","min T Mar","march","degrees Celsius","*degree*C*", +"temperature_min_04","temperature_min_04","WorldClim_2.1_INM-CM5-0_ssp245_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Apr","min T Apr","april","degrees Celsius","*degree*C*", +"temperature_min_05","temperature_min_05","WorldClim_2.1_INM-CM5-0_ssp245_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature May","min T May","may","degrees Celsius","*degree*C*", +"temperature_min_06","temperature_min_06","WorldClim_2.1_INM-CM5-0_ssp245_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jun","min T Jun","june","degrees Celsius","*degree*C*", +"temperature_min_07","temperature_min_07","WorldClim_2.1_INM-CM5-0_ssp245_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jul","min T Jul","july","degrees Celsius","*degree*C*", +"temperature_min_08","temperature_min_08","WorldClim_2.1_INM-CM5-0_ssp245_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Aug","min T Aug","august","degrees Celsius","*degree*C*", +"temperature_min_09","temperature_min_09","WorldClim_2.1_INM-CM5-0_ssp245_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Sep","min T Sep","september","degrees Celsius","*degree*C*", +"temperature_min_10","temperature_min_10","WorldClim_2.1_INM-CM5-0_ssp245_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Oct","min T Oct","october","degrees Celsius","*degree*C*", +"temperature_min_11","temperature_min_11","WorldClim_2.1_INM-CM5-0_ssp245_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Nov","min T Nov","november","degrees Celsius","*degree*C*", +"temperature_min_12","temperature_min_12","WorldClim_2.1_INM-CM5-0_ssp245_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Dec","min T Dec","december","degrees Celsius","*degree*C*", +"temperature_max_01","temperature_max_01","WorldClim_2.1_INM-CM5-0_ssp245_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jan","max T Jan","january","degrees Celsius","*degree*C*", +"temperature_max_02","temperature_max_02","WorldClim_2.1_INM-CM5-0_ssp245_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Feb","max T Feb","february","degrees Celsius","*degree*C*", +"temperature_max_03","temperature_max_03","WorldClim_2.1_INM-CM5-0_ssp245_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Mar","max T Mar","march","degrees Celsius","*degree*C*", +"temperature_max_04","temperature_max_04","WorldClim_2.1_INM-CM5-0_ssp245_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Apr","max T Apr","april","degrees Celsius","*degree*C*", +"temperature_max_05","temperature_max_05","WorldClim_2.1_INM-CM5-0_ssp245_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature May","max T May","may","degrees Celsius","*degree*C*", +"temperature_max_06","temperature_max_06","WorldClim_2.1_INM-CM5-0_ssp245_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jun","max T Jun","june","degrees Celsius","*degree*C*", +"temperature_max_07","temperature_max_07","WorldClim_2.1_INM-CM5-0_ssp245_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jul","max T Jul","july","degrees Celsius","*degree*C*", +"temperature_max_08","temperature_max_08","WorldClim_2.1_INM-CM5-0_ssp245_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Aug","max T Aug","august","degrees Celsius","*degree*C*", +"temperature_max_09","temperature_max_09","WorldClim_2.1_INM-CM5-0_ssp245_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Sep","max T Sep","september","degrees Celsius","*degree*C*", +"temperature_max_10","temperature_max_10","WorldClim_2.1_INM-CM5-0_ssp245_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Oct","max T Oct","october","degrees Celsius","*degree*C*", +"temperature_max_11","temperature_max_11","WorldClim_2.1_INM-CM5-0_ssp245_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Nov","max T Nov","november","degrees Celsius","*degree*C*", +"temperature_max_12","temperature_max_12","WorldClim_2.1_INM-CM5-0_ssp245_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Dec","max T Dec","december","degrees Celsius","*degree*C*", +"bio01","bio01","WorldClim_2.1_INM-CM5-0_ssp370_10m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual mean temperature","ann. mean T","year","degrees Celsius","*degree*C*", +"bio02","bio02","WorldClim_2.1_INM-CM5-0_ssp370_10m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean diurnal range","diurn. range","year","degrees Celsius","*degree*C*", +"bio03","bio03","WorldClim_2.1_INM-CM5-0_ssp370_10m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","isothermality","isothermality","year","","", +"bio04","bio04","WorldClim_2.1_INM-CM5-0_ssp370_10m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature seasonality","T season.","year","degrees Celsius","*degree*C*", +"bio05","bio05","WorldClim_2.1_INM-CM5-0_ssp370_10m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature of warmest month","max. T of warmest mo.","year","degrees Celsius","*degree*C*", +"bio06","bio06","WorldClim_2.1_INM-CM5-0_ssp370_10m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature of coldest month","min. T of coldest mo.","year","degrees Celsius","*degree*C*", +"bio07","bio07","WorldClim_2.1_INM-CM5-0_ssp370_10m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature annual range (bio05-bio06)","T ann. Range","year","degrees Celsius","*degree*C*", +"bio08","bio08","WorldClim_2.1_INM-CM5-0_ssp370_10m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of wettest quarter","mean T of wettest qtr","year","degrees Celsius","*degree*C*", +"bio09","bio09","WorldClim_2.1_INM-CM5-0_ssp370_10m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of driest quarter","mean T of driest qtr","year","degrees Celsius","*degree*C*", +"bio10","bio10","WorldClim_2.1_INM-CM5-0_ssp370_10m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of warmest quarter","mean T of warmest qtr","year","degrees Celsius","*degree*C*", +"bio11","bio11","WorldClim_2.1_INM-CM5-0_ssp370_10m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of coldest quarter","mean T of coldest qtr","year","degrees Celsius","*degree*C*", +"bio12","bio12","WorldClim_2.1_INM-CM5-0_ssp370_10m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual precipitation","ann. P","year","mm per year","*mm~yr^-1*", +"bio13","bio13","WorldClim_2.1_INM-CM5-0_ssp370_10m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest month","P of wettest mo.","year","mm per month","*mm~mo^-1*", +"bio14","bio14","WorldClim_2.1_INM-CM5-0_ssp370_10m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest month","P of driest mo.","year","mm per month","*mm~mo^-1*", +"bio15","bio15","WorldClim_2.1_INM-CM5-0_ssp370_10m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation seasonality (coeff var)","P season.","year","","", +"bio16","bio16","WorldClim_2.1_INM-CM5-0_ssp370_10m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest quarter","P of wettest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio17","bio17","WorldClim_2.1_INM-CM5-0_ssp370_10m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest quarter","P of driest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio18","bio18","WorldClim_2.1_INM-CM5-0_ssp370_10m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of warmest quarter","P of warmest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio19","bio19","WorldClim_2.1_INM-CM5-0_ssp370_10m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of coldest quarter","P of coldest qtr","year","mm per quarter","*mm~qtr^-1*", +"precipitation_01","precipitation_01","WorldClim_2.1_INM-CM5-0_ssp370_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jan","P Jan","january","mm per month","*mm~mo^-1*", +"precipitation_02","precipitation_02","WorldClim_2.1_INM-CM5-0_ssp370_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Feb","P Feb","february","mm per month","*mm~mo^-1*", +"precipitation_03","precipitation_03","WorldClim_2.1_INM-CM5-0_ssp370_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Mar","P Mar","march","mm per month","*mm~mo^-1*", +"precipitation_04","precipitation_04","WorldClim_2.1_INM-CM5-0_ssp370_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Apr","P Apr","april","mm per month","*mm~mo^-1*", +"precipitation_05","precipitation_05","WorldClim_2.1_INM-CM5-0_ssp370_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation May","P May","may","mm per month","*mm~mo^-1*", +"precipitation_06","precipitation_06","WorldClim_2.1_INM-CM5-0_ssp370_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jun","P Jun","june","mm per month","*mm~mo^-1*", +"precipitation_07","precipitation_07","WorldClim_2.1_INM-CM5-0_ssp370_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jul","P Jul","july","mm per month","*mm~mo^-1*", +"precipitation_08","precipitation_08","WorldClim_2.1_INM-CM5-0_ssp370_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Aug","P Aug","august","mm per month","*mm~mo^-1*", +"precipitation_09","precipitation_09","WorldClim_2.1_INM-CM5-0_ssp370_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Sep","P Sep","september","mm per month","*mm~mo^-1*", +"precipitation_10","precipitation_10","WorldClim_2.1_INM-CM5-0_ssp370_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Oct","P Oct","october","mm per month","*mm~mo^-1*", +"precipitation_11","precipitation_11","WorldClim_2.1_INM-CM5-0_ssp370_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Nov","P Nov","november","mm per month","*mm~mo^-1*", +"precipitation_12","precipitation_12","WorldClim_2.1_INM-CM5-0_ssp370_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Dec","P Dec","december","mm per month","*mm~mo^-1*", +"temperature_min_01","temperature_min_01","WorldClim_2.1_INM-CM5-0_ssp370_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jan","min T Jan","january","degrees Celsius","*degree*C*", +"temperature_min_02","temperature_min_02","WorldClim_2.1_INM-CM5-0_ssp370_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Feb","min T Feb","february","degrees Celsius","*degree*C*", +"temperature_min_03","temperature_min_03","WorldClim_2.1_INM-CM5-0_ssp370_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Mar","min T Mar","march","degrees Celsius","*degree*C*", +"temperature_min_04","temperature_min_04","WorldClim_2.1_INM-CM5-0_ssp370_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Apr","min T Apr","april","degrees Celsius","*degree*C*", +"temperature_min_05","temperature_min_05","WorldClim_2.1_INM-CM5-0_ssp370_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature May","min T May","may","degrees Celsius","*degree*C*", +"temperature_min_06","temperature_min_06","WorldClim_2.1_INM-CM5-0_ssp370_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jun","min T Jun","june","degrees Celsius","*degree*C*", +"temperature_min_07","temperature_min_07","WorldClim_2.1_INM-CM5-0_ssp370_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jul","min T Jul","july","degrees Celsius","*degree*C*", +"temperature_min_08","temperature_min_08","WorldClim_2.1_INM-CM5-0_ssp370_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Aug","min T Aug","august","degrees Celsius","*degree*C*", +"temperature_min_09","temperature_min_09","WorldClim_2.1_INM-CM5-0_ssp370_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Sep","min T Sep","september","degrees Celsius","*degree*C*", +"temperature_min_10","temperature_min_10","WorldClim_2.1_INM-CM5-0_ssp370_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Oct","min T Oct","october","degrees Celsius","*degree*C*", +"temperature_min_11","temperature_min_11","WorldClim_2.1_INM-CM5-0_ssp370_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Nov","min T Nov","november","degrees Celsius","*degree*C*", +"temperature_min_12","temperature_min_12","WorldClim_2.1_INM-CM5-0_ssp370_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Dec","min T Dec","december","degrees Celsius","*degree*C*", +"temperature_max_01","temperature_max_01","WorldClim_2.1_INM-CM5-0_ssp370_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jan","max T Jan","january","degrees Celsius","*degree*C*", +"temperature_max_02","temperature_max_02","WorldClim_2.1_INM-CM5-0_ssp370_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Feb","max T Feb","february","degrees Celsius","*degree*C*", +"temperature_max_03","temperature_max_03","WorldClim_2.1_INM-CM5-0_ssp370_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Mar","max T Mar","march","degrees Celsius","*degree*C*", +"temperature_max_04","temperature_max_04","WorldClim_2.1_INM-CM5-0_ssp370_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Apr","max T Apr","april","degrees Celsius","*degree*C*", +"temperature_max_05","temperature_max_05","WorldClim_2.1_INM-CM5-0_ssp370_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature May","max T May","may","degrees Celsius","*degree*C*", +"temperature_max_06","temperature_max_06","WorldClim_2.1_INM-CM5-0_ssp370_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jun","max T Jun","june","degrees Celsius","*degree*C*", +"temperature_max_07","temperature_max_07","WorldClim_2.1_INM-CM5-0_ssp370_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jul","max T Jul","july","degrees Celsius","*degree*C*", +"temperature_max_08","temperature_max_08","WorldClim_2.1_INM-CM5-0_ssp370_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Aug","max T Aug","august","degrees Celsius","*degree*C*", +"temperature_max_09","temperature_max_09","WorldClim_2.1_INM-CM5-0_ssp370_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Sep","max T Sep","september","degrees Celsius","*degree*C*", +"temperature_max_10","temperature_max_10","WorldClim_2.1_INM-CM5-0_ssp370_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Oct","max T Oct","october","degrees Celsius","*degree*C*", +"temperature_max_11","temperature_max_11","WorldClim_2.1_INM-CM5-0_ssp370_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Nov","max T Nov","november","degrees Celsius","*degree*C*", +"temperature_max_12","temperature_max_12","WorldClim_2.1_INM-CM5-0_ssp370_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Dec","max T Dec","december","degrees Celsius","*degree*C*", +"bio01","bio01","WorldClim_2.1_INM-CM5-0_ssp370_5m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual mean temperature","ann. mean T","year","degrees Celsius","*degree*C*", +"bio02","bio02","WorldClim_2.1_INM-CM5-0_ssp370_5m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean diurnal range","diurn. range","year","degrees Celsius","*degree*C*", +"bio03","bio03","WorldClim_2.1_INM-CM5-0_ssp370_5m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","isothermality","isothermality","year","","", +"bio04","bio04","WorldClim_2.1_INM-CM5-0_ssp370_5m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature seasonality","T season.","year","degrees Celsius","*degree*C*", +"bio05","bio05","WorldClim_2.1_INM-CM5-0_ssp370_5m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature of warmest month","max. T of warmest mo.","year","degrees Celsius","*degree*C*", +"bio06","bio06","WorldClim_2.1_INM-CM5-0_ssp370_5m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature of coldest month","min. T of coldest mo.","year","degrees Celsius","*degree*C*", +"bio07","bio07","WorldClim_2.1_INM-CM5-0_ssp370_5m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature annual range (bio05-bio06)","T ann. Range","year","degrees Celsius","*degree*C*", +"bio08","bio08","WorldClim_2.1_INM-CM5-0_ssp370_5m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of wettest quarter","mean T of wettest qtr","year","degrees Celsius","*degree*C*", +"bio09","bio09","WorldClim_2.1_INM-CM5-0_ssp370_5m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of driest quarter","mean T of driest qtr","year","degrees Celsius","*degree*C*", +"bio10","bio10","WorldClim_2.1_INM-CM5-0_ssp370_5m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of warmest quarter","mean T of warmest qtr","year","degrees Celsius","*degree*C*", +"bio11","bio11","WorldClim_2.1_INM-CM5-0_ssp370_5m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of coldest quarter","mean T of coldest qtr","year","degrees Celsius","*degree*C*", +"bio12","bio12","WorldClim_2.1_INM-CM5-0_ssp370_5m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual precipitation","ann. P","year","mm per year","*mm~yr^-1*", +"bio13","bio13","WorldClim_2.1_INM-CM5-0_ssp370_5m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest month","P of wettest mo.","year","mm per month","*mm~mo^-1*", +"bio14","bio14","WorldClim_2.1_INM-CM5-0_ssp370_5m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest month","P of driest mo.","year","mm per month","*mm~mo^-1*", +"bio15","bio15","WorldClim_2.1_INM-CM5-0_ssp370_5m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation seasonality (coeff var)","P season.","year","","", +"bio16","bio16","WorldClim_2.1_INM-CM5-0_ssp370_5m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest quarter","P of wettest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio17","bio17","WorldClim_2.1_INM-CM5-0_ssp370_5m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest quarter","P of driest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio18","bio18","WorldClim_2.1_INM-CM5-0_ssp370_5m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of warmest quarter","P of warmest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio19","bio19","WorldClim_2.1_INM-CM5-0_ssp370_5m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of coldest quarter","P of coldest qtr","year","mm per quarter","*mm~qtr^-1*", +"precipitation_01","precipitation_01","WorldClim_2.1_INM-CM5-0_ssp370_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jan","P Jan","january","mm per month","*mm~mo^-1*", +"precipitation_02","precipitation_02","WorldClim_2.1_INM-CM5-0_ssp370_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Feb","P Feb","february","mm per month","*mm~mo^-1*", +"precipitation_03","precipitation_03","WorldClim_2.1_INM-CM5-0_ssp370_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Mar","P Mar","march","mm per month","*mm~mo^-1*", +"precipitation_04","precipitation_04","WorldClim_2.1_INM-CM5-0_ssp370_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Apr","P Apr","april","mm per month","*mm~mo^-1*", +"precipitation_05","precipitation_05","WorldClim_2.1_INM-CM5-0_ssp370_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation May","P May","may","mm per month","*mm~mo^-1*", +"precipitation_06","precipitation_06","WorldClim_2.1_INM-CM5-0_ssp370_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jun","P Jun","june","mm per month","*mm~mo^-1*", +"precipitation_07","precipitation_07","WorldClim_2.1_INM-CM5-0_ssp370_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jul","P Jul","july","mm per month","*mm~mo^-1*", +"precipitation_08","precipitation_08","WorldClim_2.1_INM-CM5-0_ssp370_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Aug","P Aug","august","mm per month","*mm~mo^-1*", +"precipitation_09","precipitation_09","WorldClim_2.1_INM-CM5-0_ssp370_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Sep","P Sep","september","mm per month","*mm~mo^-1*", +"precipitation_10","precipitation_10","WorldClim_2.1_INM-CM5-0_ssp370_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Oct","P Oct","october","mm per month","*mm~mo^-1*", +"precipitation_11","precipitation_11","WorldClim_2.1_INM-CM5-0_ssp370_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Nov","P Nov","november","mm per month","*mm~mo^-1*", +"precipitation_12","precipitation_12","WorldClim_2.1_INM-CM5-0_ssp370_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Dec","P Dec","december","mm per month","*mm~mo^-1*", +"temperature_min_01","temperature_min_01","WorldClim_2.1_INM-CM5-0_ssp370_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jan","min T Jan","january","degrees Celsius","*degree*C*", +"temperature_min_02","temperature_min_02","WorldClim_2.1_INM-CM5-0_ssp370_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Feb","min T Feb","february","degrees Celsius","*degree*C*", +"temperature_min_03","temperature_min_03","WorldClim_2.1_INM-CM5-0_ssp370_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Mar","min T Mar","march","degrees Celsius","*degree*C*", +"temperature_min_04","temperature_min_04","WorldClim_2.1_INM-CM5-0_ssp370_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Apr","min T Apr","april","degrees Celsius","*degree*C*", +"temperature_min_05","temperature_min_05","WorldClim_2.1_INM-CM5-0_ssp370_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature May","min T May","may","degrees Celsius","*degree*C*", +"temperature_min_06","temperature_min_06","WorldClim_2.1_INM-CM5-0_ssp370_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jun","min T Jun","june","degrees Celsius","*degree*C*", +"temperature_min_07","temperature_min_07","WorldClim_2.1_INM-CM5-0_ssp370_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jul","min T Jul","july","degrees Celsius","*degree*C*", +"temperature_min_08","temperature_min_08","WorldClim_2.1_INM-CM5-0_ssp370_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Aug","min T Aug","august","degrees Celsius","*degree*C*", +"temperature_min_09","temperature_min_09","WorldClim_2.1_INM-CM5-0_ssp370_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Sep","min T Sep","september","degrees Celsius","*degree*C*", +"temperature_min_10","temperature_min_10","WorldClim_2.1_INM-CM5-0_ssp370_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Oct","min T Oct","october","degrees Celsius","*degree*C*", +"temperature_min_11","temperature_min_11","WorldClim_2.1_INM-CM5-0_ssp370_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Nov","min T Nov","november","degrees Celsius","*degree*C*", +"temperature_min_12","temperature_min_12","WorldClim_2.1_INM-CM5-0_ssp370_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Dec","min T Dec","december","degrees Celsius","*degree*C*", +"temperature_max_01","temperature_max_01","WorldClim_2.1_INM-CM5-0_ssp370_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jan","max T Jan","january","degrees Celsius","*degree*C*", +"temperature_max_02","temperature_max_02","WorldClim_2.1_INM-CM5-0_ssp370_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Feb","max T Feb","february","degrees Celsius","*degree*C*", +"temperature_max_03","temperature_max_03","WorldClim_2.1_INM-CM5-0_ssp370_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Mar","max T Mar","march","degrees Celsius","*degree*C*", +"temperature_max_04","temperature_max_04","WorldClim_2.1_INM-CM5-0_ssp370_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Apr","max T Apr","april","degrees Celsius","*degree*C*", +"temperature_max_05","temperature_max_05","WorldClim_2.1_INM-CM5-0_ssp370_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature May","max T May","may","degrees Celsius","*degree*C*", +"temperature_max_06","temperature_max_06","WorldClim_2.1_INM-CM5-0_ssp370_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jun","max T Jun","june","degrees Celsius","*degree*C*", +"temperature_max_07","temperature_max_07","WorldClim_2.1_INM-CM5-0_ssp370_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jul","max T Jul","july","degrees Celsius","*degree*C*", +"temperature_max_08","temperature_max_08","WorldClim_2.1_INM-CM5-0_ssp370_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Aug","max T Aug","august","degrees Celsius","*degree*C*", +"temperature_max_09","temperature_max_09","WorldClim_2.1_INM-CM5-0_ssp370_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Sep","max T Sep","september","degrees Celsius","*degree*C*", +"temperature_max_10","temperature_max_10","WorldClim_2.1_INM-CM5-0_ssp370_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Oct","max T Oct","october","degrees Celsius","*degree*C*", +"temperature_max_11","temperature_max_11","WorldClim_2.1_INM-CM5-0_ssp370_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Nov","max T Nov","november","degrees Celsius","*degree*C*", +"temperature_max_12","temperature_max_12","WorldClim_2.1_INM-CM5-0_ssp370_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Dec","max T Dec","december","degrees Celsius","*degree*C*", +"bio01","bio01","WorldClim_2.1_INM-CM5-0_ssp585_10m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual mean temperature","ann. mean T","year","degrees Celsius","*degree*C*", +"bio02","bio02","WorldClim_2.1_INM-CM5-0_ssp585_10m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean diurnal range","diurn. range","year","degrees Celsius","*degree*C*", +"bio03","bio03","WorldClim_2.1_INM-CM5-0_ssp585_10m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","isothermality","isothermality","year","","", +"bio04","bio04","WorldClim_2.1_INM-CM5-0_ssp585_10m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature seasonality","T season.","year","degrees Celsius","*degree*C*", +"bio05","bio05","WorldClim_2.1_INM-CM5-0_ssp585_10m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature of warmest month","max. T of warmest mo.","year","degrees Celsius","*degree*C*", +"bio06","bio06","WorldClim_2.1_INM-CM5-0_ssp585_10m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature of coldest month","min. T of coldest mo.","year","degrees Celsius","*degree*C*", +"bio07","bio07","WorldClim_2.1_INM-CM5-0_ssp585_10m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature annual range (bio05-bio06)","T ann. Range","year","degrees Celsius","*degree*C*", +"bio08","bio08","WorldClim_2.1_INM-CM5-0_ssp585_10m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of wettest quarter","mean T of wettest qtr","year","degrees Celsius","*degree*C*", +"bio09","bio09","WorldClim_2.1_INM-CM5-0_ssp585_10m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of driest quarter","mean T of driest qtr","year","degrees Celsius","*degree*C*", +"bio10","bio10","WorldClim_2.1_INM-CM5-0_ssp585_10m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of warmest quarter","mean T of warmest qtr","year","degrees Celsius","*degree*C*", +"bio11","bio11","WorldClim_2.1_INM-CM5-0_ssp585_10m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of coldest quarter","mean T of coldest qtr","year","degrees Celsius","*degree*C*", +"bio12","bio12","WorldClim_2.1_INM-CM5-0_ssp585_10m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual precipitation","ann. P","year","mm per year","*mm~yr^-1*", +"bio13","bio13","WorldClim_2.1_INM-CM5-0_ssp585_10m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest month","P of wettest mo.","year","mm per month","*mm~mo^-1*", +"bio14","bio14","WorldClim_2.1_INM-CM5-0_ssp585_10m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest month","P of driest mo.","year","mm per month","*mm~mo^-1*", +"bio15","bio15","WorldClim_2.1_INM-CM5-0_ssp585_10m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation seasonality (coeff var)","P season.","year","","", +"bio16","bio16","WorldClim_2.1_INM-CM5-0_ssp585_10m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest quarter","P of wettest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio17","bio17","WorldClim_2.1_INM-CM5-0_ssp585_10m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest quarter","P of driest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio18","bio18","WorldClim_2.1_INM-CM5-0_ssp585_10m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of warmest quarter","P of warmest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio19","bio19","WorldClim_2.1_INM-CM5-0_ssp585_10m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of coldest quarter","P of coldest qtr","year","mm per quarter","*mm~qtr^-1*", +"precipitation_01","precipitation_01","WorldClim_2.1_INM-CM5-0_ssp585_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jan","P Jan","january","mm per month","*mm~mo^-1*", +"precipitation_02","precipitation_02","WorldClim_2.1_INM-CM5-0_ssp585_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Feb","P Feb","february","mm per month","*mm~mo^-1*", +"precipitation_03","precipitation_03","WorldClim_2.1_INM-CM5-0_ssp585_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Mar","P Mar","march","mm per month","*mm~mo^-1*", +"precipitation_04","precipitation_04","WorldClim_2.1_INM-CM5-0_ssp585_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Apr","P Apr","april","mm per month","*mm~mo^-1*", +"precipitation_05","precipitation_05","WorldClim_2.1_INM-CM5-0_ssp585_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation May","P May","may","mm per month","*mm~mo^-1*", +"precipitation_06","precipitation_06","WorldClim_2.1_INM-CM5-0_ssp585_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jun","P Jun","june","mm per month","*mm~mo^-1*", +"precipitation_07","precipitation_07","WorldClim_2.1_INM-CM5-0_ssp585_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jul","P Jul","july","mm per month","*mm~mo^-1*", +"precipitation_08","precipitation_08","WorldClim_2.1_INM-CM5-0_ssp585_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Aug","P Aug","august","mm per month","*mm~mo^-1*", +"precipitation_09","precipitation_09","WorldClim_2.1_INM-CM5-0_ssp585_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Sep","P Sep","september","mm per month","*mm~mo^-1*", +"precipitation_10","precipitation_10","WorldClim_2.1_INM-CM5-0_ssp585_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Oct","P Oct","october","mm per month","*mm~mo^-1*", +"precipitation_11","precipitation_11","WorldClim_2.1_INM-CM5-0_ssp585_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Nov","P Nov","november","mm per month","*mm~mo^-1*", +"precipitation_12","precipitation_12","WorldClim_2.1_INM-CM5-0_ssp585_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Dec","P Dec","december","mm per month","*mm~mo^-1*", +"temperature_min_01","temperature_min_01","WorldClim_2.1_INM-CM5-0_ssp585_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jan","min T Jan","january","degrees Celsius","*degree*C*", +"temperature_min_02","temperature_min_02","WorldClim_2.1_INM-CM5-0_ssp585_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Feb","min T Feb","february","degrees Celsius","*degree*C*", +"temperature_min_03","temperature_min_03","WorldClim_2.1_INM-CM5-0_ssp585_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Mar","min T Mar","march","degrees Celsius","*degree*C*", +"temperature_min_04","temperature_min_04","WorldClim_2.1_INM-CM5-0_ssp585_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Apr","min T Apr","april","degrees Celsius","*degree*C*", +"temperature_min_05","temperature_min_05","WorldClim_2.1_INM-CM5-0_ssp585_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature May","min T May","may","degrees Celsius","*degree*C*", +"temperature_min_06","temperature_min_06","WorldClim_2.1_INM-CM5-0_ssp585_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jun","min T Jun","june","degrees Celsius","*degree*C*", +"temperature_min_07","temperature_min_07","WorldClim_2.1_INM-CM5-0_ssp585_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jul","min T Jul","july","degrees Celsius","*degree*C*", +"temperature_min_08","temperature_min_08","WorldClim_2.1_INM-CM5-0_ssp585_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Aug","min T Aug","august","degrees Celsius","*degree*C*", +"temperature_min_09","temperature_min_09","WorldClim_2.1_INM-CM5-0_ssp585_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Sep","min T Sep","september","degrees Celsius","*degree*C*", +"temperature_min_10","temperature_min_10","WorldClim_2.1_INM-CM5-0_ssp585_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Oct","min T Oct","october","degrees Celsius","*degree*C*", +"temperature_min_11","temperature_min_11","WorldClim_2.1_INM-CM5-0_ssp585_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Nov","min T Nov","november","degrees Celsius","*degree*C*", +"temperature_min_12","temperature_min_12","WorldClim_2.1_INM-CM5-0_ssp585_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Dec","min T Dec","december","degrees Celsius","*degree*C*", +"temperature_max_01","temperature_max_01","WorldClim_2.1_INM-CM5-0_ssp585_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jan","max T Jan","january","degrees Celsius","*degree*C*", +"temperature_max_02","temperature_max_02","WorldClim_2.1_INM-CM5-0_ssp585_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Feb","max T Feb","february","degrees Celsius","*degree*C*", +"temperature_max_03","temperature_max_03","WorldClim_2.1_INM-CM5-0_ssp585_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Mar","max T Mar","march","degrees Celsius","*degree*C*", +"temperature_max_04","temperature_max_04","WorldClim_2.1_INM-CM5-0_ssp585_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Apr","max T Apr","april","degrees Celsius","*degree*C*", +"temperature_max_05","temperature_max_05","WorldClim_2.1_INM-CM5-0_ssp585_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature May","max T May","may","degrees Celsius","*degree*C*", +"temperature_max_06","temperature_max_06","WorldClim_2.1_INM-CM5-0_ssp585_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jun","max T Jun","june","degrees Celsius","*degree*C*", +"temperature_max_07","temperature_max_07","WorldClim_2.1_INM-CM5-0_ssp585_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jul","max T Jul","july","degrees Celsius","*degree*C*", +"temperature_max_08","temperature_max_08","WorldClim_2.1_INM-CM5-0_ssp585_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Aug","max T Aug","august","degrees Celsius","*degree*C*", +"temperature_max_09","temperature_max_09","WorldClim_2.1_INM-CM5-0_ssp585_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Sep","max T Sep","september","degrees Celsius","*degree*C*", +"temperature_max_10","temperature_max_10","WorldClim_2.1_INM-CM5-0_ssp585_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Oct","max T Oct","october","degrees Celsius","*degree*C*", +"temperature_max_11","temperature_max_11","WorldClim_2.1_INM-CM5-0_ssp585_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Nov","max T Nov","november","degrees Celsius","*degree*C*", +"temperature_max_12","temperature_max_12","WorldClim_2.1_INM-CM5-0_ssp585_10m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Dec","max T Dec","december","degrees Celsius","*degree*C*", +"bio01","bio01","WorldClim_2.1_INM-CM5-0_ssp585_5m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual mean temperature","ann. mean T","year","degrees Celsius","*degree*C*", +"bio02","bio02","WorldClim_2.1_INM-CM5-0_ssp585_5m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean diurnal range","diurn. range","year","degrees Celsius","*degree*C*", +"bio03","bio03","WorldClim_2.1_INM-CM5-0_ssp585_5m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","isothermality","isothermality","year","","", +"bio04","bio04","WorldClim_2.1_INM-CM5-0_ssp585_5m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature seasonality","T season.","year","degrees Celsius","*degree*C*", +"bio05","bio05","WorldClim_2.1_INM-CM5-0_ssp585_5m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature of warmest month","max. T of warmest mo.","year","degrees Celsius","*degree*C*", +"bio06","bio06","WorldClim_2.1_INM-CM5-0_ssp585_5m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature of coldest month","min. T of coldest mo.","year","degrees Celsius","*degree*C*", +"bio07","bio07","WorldClim_2.1_INM-CM5-0_ssp585_5m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature annual range (bio05-bio06)","T ann. Range","year","degrees Celsius","*degree*C*", +"bio08","bio08","WorldClim_2.1_INM-CM5-0_ssp585_5m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of wettest quarter","mean T of wettest qtr","year","degrees Celsius","*degree*C*", +"bio09","bio09","WorldClim_2.1_INM-CM5-0_ssp585_5m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of driest quarter","mean T of driest qtr","year","degrees Celsius","*degree*C*", +"bio10","bio10","WorldClim_2.1_INM-CM5-0_ssp585_5m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of warmest quarter","mean T of warmest qtr","year","degrees Celsius","*degree*C*", +"bio11","bio11","WorldClim_2.1_INM-CM5-0_ssp585_5m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of coldest quarter","mean T of coldest qtr","year","degrees Celsius","*degree*C*", +"bio12","bio12","WorldClim_2.1_INM-CM5-0_ssp585_5m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual precipitation","ann. P","year","mm per year","*mm~yr^-1*", +"bio13","bio13","WorldClim_2.1_INM-CM5-0_ssp585_5m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest month","P of wettest mo.","year","mm per month","*mm~mo^-1*", +"bio14","bio14","WorldClim_2.1_INM-CM5-0_ssp585_5m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest month","P of driest mo.","year","mm per month","*mm~mo^-1*", +"bio15","bio15","WorldClim_2.1_INM-CM5-0_ssp585_5m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation seasonality (coeff var)","P season.","year","","", +"bio16","bio16","WorldClim_2.1_INM-CM5-0_ssp585_5m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest quarter","P of wettest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio17","bio17","WorldClim_2.1_INM-CM5-0_ssp585_5m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest quarter","P of driest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio18","bio18","WorldClim_2.1_INM-CM5-0_ssp585_5m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of warmest quarter","P of warmest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio19","bio19","WorldClim_2.1_INM-CM5-0_ssp585_5m",FALSE,"WorldClim_2.1_INM-CM5-0_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of coldest quarter","P of coldest qtr","year","mm per quarter","*mm~qtr^-1*", +"precipitation_01","precipitation_01","WorldClim_2.1_INM-CM5-0_ssp585_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jan","P Jan","january","mm per month","*mm~mo^-1*", +"precipitation_02","precipitation_02","WorldClim_2.1_INM-CM5-0_ssp585_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Feb","P Feb","february","mm per month","*mm~mo^-1*", +"precipitation_03","precipitation_03","WorldClim_2.1_INM-CM5-0_ssp585_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Mar","P Mar","march","mm per month","*mm~mo^-1*", +"precipitation_04","precipitation_04","WorldClim_2.1_INM-CM5-0_ssp585_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Apr","P Apr","april","mm per month","*mm~mo^-1*", +"precipitation_05","precipitation_05","WorldClim_2.1_INM-CM5-0_ssp585_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation May","P May","may","mm per month","*mm~mo^-1*", +"precipitation_06","precipitation_06","WorldClim_2.1_INM-CM5-0_ssp585_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jun","P Jun","june","mm per month","*mm~mo^-1*", +"precipitation_07","precipitation_07","WorldClim_2.1_INM-CM5-0_ssp585_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jul","P Jul","july","mm per month","*mm~mo^-1*", +"precipitation_08","precipitation_08","WorldClim_2.1_INM-CM5-0_ssp585_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Aug","P Aug","august","mm per month","*mm~mo^-1*", +"precipitation_09","precipitation_09","WorldClim_2.1_INM-CM5-0_ssp585_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Sep","P Sep","september","mm per month","*mm~mo^-1*", +"precipitation_10","precipitation_10","WorldClim_2.1_INM-CM5-0_ssp585_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Oct","P Oct","october","mm per month","*mm~mo^-1*", +"precipitation_11","precipitation_11","WorldClim_2.1_INM-CM5-0_ssp585_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Nov","P Nov","november","mm per month","*mm~mo^-1*", +"precipitation_12","precipitation_12","WorldClim_2.1_INM-CM5-0_ssp585_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Dec","P Dec","december","mm per month","*mm~mo^-1*", +"temperature_min_01","temperature_min_01","WorldClim_2.1_INM-CM5-0_ssp585_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jan","min T Jan","january","degrees Celsius","*degree*C*", +"temperature_min_02","temperature_min_02","WorldClim_2.1_INM-CM5-0_ssp585_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Feb","min T Feb","february","degrees Celsius","*degree*C*", +"temperature_min_03","temperature_min_03","WorldClim_2.1_INM-CM5-0_ssp585_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Mar","min T Mar","march","degrees Celsius","*degree*C*", +"temperature_min_04","temperature_min_04","WorldClim_2.1_INM-CM5-0_ssp585_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Apr","min T Apr","april","degrees Celsius","*degree*C*", +"temperature_min_05","temperature_min_05","WorldClim_2.1_INM-CM5-0_ssp585_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature May","min T May","may","degrees Celsius","*degree*C*", +"temperature_min_06","temperature_min_06","WorldClim_2.1_INM-CM5-0_ssp585_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jun","min T Jun","june","degrees Celsius","*degree*C*", +"temperature_min_07","temperature_min_07","WorldClim_2.1_INM-CM5-0_ssp585_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jul","min T Jul","july","degrees Celsius","*degree*C*", +"temperature_min_08","temperature_min_08","WorldClim_2.1_INM-CM5-0_ssp585_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Aug","min T Aug","august","degrees Celsius","*degree*C*", +"temperature_min_09","temperature_min_09","WorldClim_2.1_INM-CM5-0_ssp585_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Sep","min T Sep","september","degrees Celsius","*degree*C*", +"temperature_min_10","temperature_min_10","WorldClim_2.1_INM-CM5-0_ssp585_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Oct","min T Oct","october","degrees Celsius","*degree*C*", +"temperature_min_11","temperature_min_11","WorldClim_2.1_INM-CM5-0_ssp585_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Nov","min T Nov","november","degrees Celsius","*degree*C*", +"temperature_min_12","temperature_min_12","WorldClim_2.1_INM-CM5-0_ssp585_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Dec","min T Dec","december","degrees Celsius","*degree*C*", +"temperature_max_01","temperature_max_01","WorldClim_2.1_INM-CM5-0_ssp585_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jan","max T Jan","january","degrees Celsius","*degree*C*", +"temperature_max_02","temperature_max_02","WorldClim_2.1_INM-CM5-0_ssp585_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Feb","max T Feb","february","degrees Celsius","*degree*C*", +"temperature_max_03","temperature_max_03","WorldClim_2.1_INM-CM5-0_ssp585_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Mar","max T Mar","march","degrees Celsius","*degree*C*", +"temperature_max_04","temperature_max_04","WorldClim_2.1_INM-CM5-0_ssp585_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Apr","max T Apr","april","degrees Celsius","*degree*C*", +"temperature_max_05","temperature_max_05","WorldClim_2.1_INM-CM5-0_ssp585_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature May","max T May","may","degrees Celsius","*degree*C*", +"temperature_max_06","temperature_max_06","WorldClim_2.1_INM-CM5-0_ssp585_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jun","max T Jun","june","degrees Celsius","*degree*C*", +"temperature_max_07","temperature_max_07","WorldClim_2.1_INM-CM5-0_ssp585_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jul","max T Jul","july","degrees Celsius","*degree*C*", +"temperature_max_08","temperature_max_08","WorldClim_2.1_INM-CM5-0_ssp585_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Aug","max T Aug","august","degrees Celsius","*degree*C*", +"temperature_max_09","temperature_max_09","WorldClim_2.1_INM-CM5-0_ssp585_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Sep","max T Sep","september","degrees Celsius","*degree*C*", +"temperature_max_10","temperature_max_10","WorldClim_2.1_INM-CM5-0_ssp585_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Oct","max T Oct","october","degrees Celsius","*degree*C*", +"temperature_max_11","temperature_max_11","WorldClim_2.1_INM-CM5-0_ssp585_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Nov","max T Nov","november","degrees Celsius","*degree*C*", +"temperature_max_12","temperature_max_12","WorldClim_2.1_INM-CM5-0_ssp585_5m",TRUE,"WorldClim_2.1_INM-CM5-0_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Dec","max T Dec","december","degrees Celsius","*degree*C*", +"bio01","bio01","WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual mean temperature","ann. mean T","year","degrees Celsius","*degree*C*", +"bio02","bio02","WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean diurnal range","diurn. range","year","degrees Celsius","*degree*C*", +"bio03","bio03","WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","isothermality","isothermality","year","","", +"bio04","bio04","WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature seasonality","T season.","year","degrees Celsius","*degree*C*", +"bio05","bio05","WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature of warmest month","max. T of warmest mo.","year","degrees Celsius","*degree*C*", +"bio06","bio06","WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature of coldest month","min. T of coldest mo.","year","degrees Celsius","*degree*C*", +"bio07","bio07","WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature annual range (bio05-bio06)","T ann. Range","year","degrees Celsius","*degree*C*", +"bio08","bio08","WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of wettest quarter","mean T of wettest qtr","year","degrees Celsius","*degree*C*", +"bio09","bio09","WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of driest quarter","mean T of driest qtr","year","degrees Celsius","*degree*C*", +"bio10","bio10","WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of warmest quarter","mean T of warmest qtr","year","degrees Celsius","*degree*C*", +"bio11","bio11","WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of coldest quarter","mean T of coldest qtr","year","degrees Celsius","*degree*C*", +"bio12","bio12","WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual precipitation","ann. P","year","mm per year","*mm~yr^-1*", +"bio13","bio13","WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest month","P of wettest mo.","year","mm per month","*mm~mo^-1*", +"bio14","bio14","WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest month","P of driest mo.","year","mm per month","*mm~mo^-1*", +"bio15","bio15","WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation seasonality (coeff var)","P season.","year","","", +"bio16","bio16","WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest quarter","P of wettest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio17","bio17","WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest quarter","P of driest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio18","bio18","WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of warmest quarter","P of warmest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio19","bio19","WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of coldest quarter","P of coldest qtr","year","mm per quarter","*mm~qtr^-1*", +"precipitation_01","precipitation_01","WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jan","P Jan","january","mm per month","*mm~mo^-1*", +"precipitation_02","precipitation_02","WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Feb","P Feb","february","mm per month","*mm~mo^-1*", +"precipitation_03","precipitation_03","WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Mar","P Mar","march","mm per month","*mm~mo^-1*", +"precipitation_04","precipitation_04","WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Apr","P Apr","april","mm per month","*mm~mo^-1*", +"precipitation_05","precipitation_05","WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation May","P May","may","mm per month","*mm~mo^-1*", +"precipitation_06","precipitation_06","WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jun","P Jun","june","mm per month","*mm~mo^-1*", +"precipitation_07","precipitation_07","WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jul","P Jul","july","mm per month","*mm~mo^-1*", +"precipitation_08","precipitation_08","WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Aug","P Aug","august","mm per month","*mm~mo^-1*", +"precipitation_09","precipitation_09","WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Sep","P Sep","september","mm per month","*mm~mo^-1*", +"precipitation_10","precipitation_10","WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Oct","P Oct","october","mm per month","*mm~mo^-1*", +"precipitation_11","precipitation_11","WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Nov","P Nov","november","mm per month","*mm~mo^-1*", +"precipitation_12","precipitation_12","WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Dec","P Dec","december","mm per month","*mm~mo^-1*", +"temperature_min_01","temperature_min_01","WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jan","min T Jan","january","degrees Celsius","*degree*C*", +"temperature_min_02","temperature_min_02","WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Feb","min T Feb","february","degrees Celsius","*degree*C*", +"temperature_min_03","temperature_min_03","WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Mar","min T Mar","march","degrees Celsius","*degree*C*", +"temperature_min_04","temperature_min_04","WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Apr","min T Apr","april","degrees Celsius","*degree*C*", +"temperature_min_05","temperature_min_05","WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature May","min T May","may","degrees Celsius","*degree*C*", +"temperature_min_06","temperature_min_06","WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jun","min T Jun","june","degrees Celsius","*degree*C*", +"temperature_min_07","temperature_min_07","WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jul","min T Jul","july","degrees Celsius","*degree*C*", +"temperature_min_08","temperature_min_08","WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Aug","min T Aug","august","degrees Celsius","*degree*C*", +"temperature_min_09","temperature_min_09","WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Sep","min T Sep","september","degrees Celsius","*degree*C*", +"temperature_min_10","temperature_min_10","WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Oct","min T Oct","october","degrees Celsius","*degree*C*", +"temperature_min_11","temperature_min_11","WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Nov","min T Nov","november","degrees Celsius","*degree*C*", +"temperature_min_12","temperature_min_12","WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Dec","min T Dec","december","degrees Celsius","*degree*C*", +"temperature_max_01","temperature_max_01","WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jan","max T Jan","january","degrees Celsius","*degree*C*", +"temperature_max_02","temperature_max_02","WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Feb","max T Feb","february","degrees Celsius","*degree*C*", +"temperature_max_03","temperature_max_03","WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Mar","max T Mar","march","degrees Celsius","*degree*C*", +"temperature_max_04","temperature_max_04","WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Apr","max T Apr","april","degrees Celsius","*degree*C*", +"temperature_max_05","temperature_max_05","WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature May","max T May","may","degrees Celsius","*degree*C*", +"temperature_max_06","temperature_max_06","WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jun","max T Jun","june","degrees Celsius","*degree*C*", +"temperature_max_07","temperature_max_07","WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jul","max T Jul","july","degrees Celsius","*degree*C*", +"temperature_max_08","temperature_max_08","WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Aug","max T Aug","august","degrees Celsius","*degree*C*", +"temperature_max_09","temperature_max_09","WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Sep","max T Sep","september","degrees Celsius","*degree*C*", +"temperature_max_10","temperature_max_10","WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Oct","max T Oct","october","degrees Celsius","*degree*C*", +"temperature_max_11","temperature_max_11","WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Nov","max T Nov","november","degrees Celsius","*degree*C*", +"temperature_max_12","temperature_max_12","WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Dec","max T Dec","december","degrees Celsius","*degree*C*", +"bio01","bio01","WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual mean temperature","ann. mean T","year","degrees Celsius","*degree*C*", +"bio02","bio02","WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean diurnal range","diurn. range","year","degrees Celsius","*degree*C*", +"bio03","bio03","WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","isothermality","isothermality","year","","", +"bio04","bio04","WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature seasonality","T season.","year","degrees Celsius","*degree*C*", +"bio05","bio05","WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature of warmest month","max. T of warmest mo.","year","degrees Celsius","*degree*C*", +"bio06","bio06","WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature of coldest month","min. T of coldest mo.","year","degrees Celsius","*degree*C*", +"bio07","bio07","WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature annual range (bio05-bio06)","T ann. Range","year","degrees Celsius","*degree*C*", +"bio08","bio08","WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of wettest quarter","mean T of wettest qtr","year","degrees Celsius","*degree*C*", +"bio09","bio09","WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of driest quarter","mean T of driest qtr","year","degrees Celsius","*degree*C*", +"bio10","bio10","WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of warmest quarter","mean T of warmest qtr","year","degrees Celsius","*degree*C*", +"bio11","bio11","WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of coldest quarter","mean T of coldest qtr","year","degrees Celsius","*degree*C*", +"bio12","bio12","WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual precipitation","ann. P","year","mm per year","*mm~yr^-1*", +"bio13","bio13","WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest month","P of wettest mo.","year","mm per month","*mm~mo^-1*", +"bio14","bio14","WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest month","P of driest mo.","year","mm per month","*mm~mo^-1*", +"bio15","bio15","WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation seasonality (coeff var)","P season.","year","","", +"bio16","bio16","WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest quarter","P of wettest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio17","bio17","WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest quarter","P of driest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio18","bio18","WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of warmest quarter","P of warmest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio19","bio19","WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of coldest quarter","P of coldest qtr","year","mm per quarter","*mm~qtr^-1*", +"precipitation_01","precipitation_01","WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jan","P Jan","january","mm per month","*mm~mo^-1*", +"precipitation_02","precipitation_02","WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Feb","P Feb","february","mm per month","*mm~mo^-1*", +"precipitation_03","precipitation_03","WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Mar","P Mar","march","mm per month","*mm~mo^-1*", +"precipitation_04","precipitation_04","WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Apr","P Apr","april","mm per month","*mm~mo^-1*", +"precipitation_05","precipitation_05","WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation May","P May","may","mm per month","*mm~mo^-1*", +"precipitation_06","precipitation_06","WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jun","P Jun","june","mm per month","*mm~mo^-1*", +"precipitation_07","precipitation_07","WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jul","P Jul","july","mm per month","*mm~mo^-1*", +"precipitation_08","precipitation_08","WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Aug","P Aug","august","mm per month","*mm~mo^-1*", +"precipitation_09","precipitation_09","WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Sep","P Sep","september","mm per month","*mm~mo^-1*", +"precipitation_10","precipitation_10","WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Oct","P Oct","october","mm per month","*mm~mo^-1*", +"precipitation_11","precipitation_11","WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Nov","P Nov","november","mm per month","*mm~mo^-1*", +"precipitation_12","precipitation_12","WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Dec","P Dec","december","mm per month","*mm~mo^-1*", +"temperature_min_01","temperature_min_01","WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jan","min T Jan","january","degrees Celsius","*degree*C*", +"temperature_min_02","temperature_min_02","WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Feb","min T Feb","february","degrees Celsius","*degree*C*", +"temperature_min_03","temperature_min_03","WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Mar","min T Mar","march","degrees Celsius","*degree*C*", +"temperature_min_04","temperature_min_04","WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Apr","min T Apr","april","degrees Celsius","*degree*C*", +"temperature_min_05","temperature_min_05","WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature May","min T May","may","degrees Celsius","*degree*C*", +"temperature_min_06","temperature_min_06","WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jun","min T Jun","june","degrees Celsius","*degree*C*", +"temperature_min_07","temperature_min_07","WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jul","min T Jul","july","degrees Celsius","*degree*C*", +"temperature_min_08","temperature_min_08","WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Aug","min T Aug","august","degrees Celsius","*degree*C*", +"temperature_min_09","temperature_min_09","WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Sep","min T Sep","september","degrees Celsius","*degree*C*", +"temperature_min_10","temperature_min_10","WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Oct","min T Oct","october","degrees Celsius","*degree*C*", +"temperature_min_11","temperature_min_11","WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Nov","min T Nov","november","degrees Celsius","*degree*C*", +"temperature_min_12","temperature_min_12","WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Dec","min T Dec","december","degrees Celsius","*degree*C*", +"temperature_max_01","temperature_max_01","WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jan","max T Jan","january","degrees Celsius","*degree*C*", +"temperature_max_02","temperature_max_02","WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Feb","max T Feb","february","degrees Celsius","*degree*C*", +"temperature_max_03","temperature_max_03","WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Mar","max T Mar","march","degrees Celsius","*degree*C*", +"temperature_max_04","temperature_max_04","WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Apr","max T Apr","april","degrees Celsius","*degree*C*", +"temperature_max_05","temperature_max_05","WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature May","max T May","may","degrees Celsius","*degree*C*", +"temperature_max_06","temperature_max_06","WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jun","max T Jun","june","degrees Celsius","*degree*C*", +"temperature_max_07","temperature_max_07","WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jul","max T Jul","july","degrees Celsius","*degree*C*", +"temperature_max_08","temperature_max_08","WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Aug","max T Aug","august","degrees Celsius","*degree*C*", +"temperature_max_09","temperature_max_09","WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Sep","max T Sep","september","degrees Celsius","*degree*C*", +"temperature_max_10","temperature_max_10","WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Oct","max T Oct","october","degrees Celsius","*degree*C*", +"temperature_max_11","temperature_max_11","WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Nov","max T Nov","november","degrees Celsius","*degree*C*", +"temperature_max_12","temperature_max_12","WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Dec","max T Dec","december","degrees Celsius","*degree*C*", +"bio01","bio01","WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual mean temperature","ann. mean T","year","degrees Celsius","*degree*C*", +"bio02","bio02","WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean diurnal range","diurn. range","year","degrees Celsius","*degree*C*", +"bio03","bio03","WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","isothermality","isothermality","year","","", +"bio04","bio04","WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature seasonality","T season.","year","degrees Celsius","*degree*C*", +"bio05","bio05","WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature of warmest month","max. T of warmest mo.","year","degrees Celsius","*degree*C*", +"bio06","bio06","WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature of coldest month","min. T of coldest mo.","year","degrees Celsius","*degree*C*", +"bio07","bio07","WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature annual range (bio05-bio06)","T ann. Range","year","degrees Celsius","*degree*C*", +"bio08","bio08","WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of wettest quarter","mean T of wettest qtr","year","degrees Celsius","*degree*C*", +"bio09","bio09","WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of driest quarter","mean T of driest qtr","year","degrees Celsius","*degree*C*", +"bio10","bio10","WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of warmest quarter","mean T of warmest qtr","year","degrees Celsius","*degree*C*", +"bio11","bio11","WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of coldest quarter","mean T of coldest qtr","year","degrees Celsius","*degree*C*", +"bio12","bio12","WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual precipitation","ann. P","year","mm per year","*mm~yr^-1*", +"bio13","bio13","WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest month","P of wettest mo.","year","mm per month","*mm~mo^-1*", +"bio14","bio14","WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest month","P of driest mo.","year","mm per month","*mm~mo^-1*", +"bio15","bio15","WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation seasonality (coeff var)","P season.","year","","", +"bio16","bio16","WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest quarter","P of wettest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio17","bio17","WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest quarter","P of driest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio18","bio18","WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of warmest quarter","P of warmest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio19","bio19","WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of coldest quarter","P of coldest qtr","year","mm per quarter","*mm~qtr^-1*", +"precipitation_01","precipitation_01","WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jan","P Jan","january","mm per month","*mm~mo^-1*", +"precipitation_02","precipitation_02","WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Feb","P Feb","february","mm per month","*mm~mo^-1*", +"precipitation_03","precipitation_03","WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Mar","P Mar","march","mm per month","*mm~mo^-1*", +"precipitation_04","precipitation_04","WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Apr","P Apr","april","mm per month","*mm~mo^-1*", +"precipitation_05","precipitation_05","WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation May","P May","may","mm per month","*mm~mo^-1*", +"precipitation_06","precipitation_06","WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jun","P Jun","june","mm per month","*mm~mo^-1*", +"precipitation_07","precipitation_07","WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jul","P Jul","july","mm per month","*mm~mo^-1*", +"precipitation_08","precipitation_08","WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Aug","P Aug","august","mm per month","*mm~mo^-1*", +"precipitation_09","precipitation_09","WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Sep","P Sep","september","mm per month","*mm~mo^-1*", +"precipitation_10","precipitation_10","WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Oct","P Oct","october","mm per month","*mm~mo^-1*", +"precipitation_11","precipitation_11","WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Nov","P Nov","november","mm per month","*mm~mo^-1*", +"precipitation_12","precipitation_12","WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Dec","P Dec","december","mm per month","*mm~mo^-1*", +"temperature_min_01","temperature_min_01","WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jan","min T Jan","january","degrees Celsius","*degree*C*", +"temperature_min_02","temperature_min_02","WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Feb","min T Feb","february","degrees Celsius","*degree*C*", +"temperature_min_03","temperature_min_03","WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Mar","min T Mar","march","degrees Celsius","*degree*C*", +"temperature_min_04","temperature_min_04","WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Apr","min T Apr","april","degrees Celsius","*degree*C*", +"temperature_min_05","temperature_min_05","WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature May","min T May","may","degrees Celsius","*degree*C*", +"temperature_min_06","temperature_min_06","WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jun","min T Jun","june","degrees Celsius","*degree*C*", +"temperature_min_07","temperature_min_07","WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jul","min T Jul","july","degrees Celsius","*degree*C*", +"temperature_min_08","temperature_min_08","WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Aug","min T Aug","august","degrees Celsius","*degree*C*", +"temperature_min_09","temperature_min_09","WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Sep","min T Sep","september","degrees Celsius","*degree*C*", +"temperature_min_10","temperature_min_10","WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Oct","min T Oct","october","degrees Celsius","*degree*C*", +"temperature_min_11","temperature_min_11","WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Nov","min T Nov","november","degrees Celsius","*degree*C*", +"temperature_min_12","temperature_min_12","WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Dec","min T Dec","december","degrees Celsius","*degree*C*", +"temperature_max_01","temperature_max_01","WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jan","max T Jan","january","degrees Celsius","*degree*C*", +"temperature_max_02","temperature_max_02","WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Feb","max T Feb","february","degrees Celsius","*degree*C*", +"temperature_max_03","temperature_max_03","WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Mar","max T Mar","march","degrees Celsius","*degree*C*", +"temperature_max_04","temperature_max_04","WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Apr","max T Apr","april","degrees Celsius","*degree*C*", +"temperature_max_05","temperature_max_05","WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature May","max T May","may","degrees Celsius","*degree*C*", +"temperature_max_06","temperature_max_06","WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jun","max T Jun","june","degrees Celsius","*degree*C*", +"temperature_max_07","temperature_max_07","WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jul","max T Jul","july","degrees Celsius","*degree*C*", +"temperature_max_08","temperature_max_08","WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Aug","max T Aug","august","degrees Celsius","*degree*C*", +"temperature_max_09","temperature_max_09","WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Sep","max T Sep","september","degrees Celsius","*degree*C*", +"temperature_max_10","temperature_max_10","WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Oct","max T Oct","october","degrees Celsius","*degree*C*", +"temperature_max_11","temperature_max_11","WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Nov","max T Nov","november","degrees Celsius","*degree*C*", +"temperature_max_12","temperature_max_12","WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Dec","max T Dec","december","degrees Celsius","*degree*C*", +"bio01","bio01","WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual mean temperature","ann. mean T","year","degrees Celsius","*degree*C*", +"bio02","bio02","WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean diurnal range","diurn. range","year","degrees Celsius","*degree*C*", +"bio03","bio03","WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","isothermality","isothermality","year","","", +"bio04","bio04","WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature seasonality","T season.","year","degrees Celsius","*degree*C*", +"bio05","bio05","WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature of warmest month","max. T of warmest mo.","year","degrees Celsius","*degree*C*", +"bio06","bio06","WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature of coldest month","min. T of coldest mo.","year","degrees Celsius","*degree*C*", +"bio07","bio07","WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature annual range (bio05-bio06)","T ann. Range","year","degrees Celsius","*degree*C*", +"bio08","bio08","WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of wettest quarter","mean T of wettest qtr","year","degrees Celsius","*degree*C*", +"bio09","bio09","WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of driest quarter","mean T of driest qtr","year","degrees Celsius","*degree*C*", +"bio10","bio10","WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of warmest quarter","mean T of warmest qtr","year","degrees Celsius","*degree*C*", +"bio11","bio11","WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of coldest quarter","mean T of coldest qtr","year","degrees Celsius","*degree*C*", +"bio12","bio12","WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual precipitation","ann. P","year","mm per year","*mm~yr^-1*", +"bio13","bio13","WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest month","P of wettest mo.","year","mm per month","*mm~mo^-1*", +"bio14","bio14","WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest month","P of driest mo.","year","mm per month","*mm~mo^-1*", +"bio15","bio15","WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation seasonality (coeff var)","P season.","year","","", +"bio16","bio16","WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest quarter","P of wettest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio17","bio17","WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest quarter","P of driest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio18","bio18","WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of warmest quarter","P of warmest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio19","bio19","WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of coldest quarter","P of coldest qtr","year","mm per quarter","*mm~qtr^-1*", +"precipitation_01","precipitation_01","WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jan","P Jan","january","mm per month","*mm~mo^-1*", +"precipitation_02","precipitation_02","WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Feb","P Feb","february","mm per month","*mm~mo^-1*", +"precipitation_03","precipitation_03","WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Mar","P Mar","march","mm per month","*mm~mo^-1*", +"precipitation_04","precipitation_04","WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Apr","P Apr","april","mm per month","*mm~mo^-1*", +"precipitation_05","precipitation_05","WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation May","P May","may","mm per month","*mm~mo^-1*", +"precipitation_06","precipitation_06","WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jun","P Jun","june","mm per month","*mm~mo^-1*", +"precipitation_07","precipitation_07","WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jul","P Jul","july","mm per month","*mm~mo^-1*", +"precipitation_08","precipitation_08","WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Aug","P Aug","august","mm per month","*mm~mo^-1*", +"precipitation_09","precipitation_09","WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Sep","P Sep","september","mm per month","*mm~mo^-1*", +"precipitation_10","precipitation_10","WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Oct","P Oct","october","mm per month","*mm~mo^-1*", +"precipitation_11","precipitation_11","WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Nov","P Nov","november","mm per month","*mm~mo^-1*", +"precipitation_12","precipitation_12","WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Dec","P Dec","december","mm per month","*mm~mo^-1*", +"temperature_min_01","temperature_min_01","WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jan","min T Jan","january","degrees Celsius","*degree*C*", +"temperature_min_02","temperature_min_02","WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Feb","min T Feb","february","degrees Celsius","*degree*C*", +"temperature_min_03","temperature_min_03","WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Mar","min T Mar","march","degrees Celsius","*degree*C*", +"temperature_min_04","temperature_min_04","WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Apr","min T Apr","april","degrees Celsius","*degree*C*", +"temperature_min_05","temperature_min_05","WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature May","min T May","may","degrees Celsius","*degree*C*", +"temperature_min_06","temperature_min_06","WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jun","min T Jun","june","degrees Celsius","*degree*C*", +"temperature_min_07","temperature_min_07","WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jul","min T Jul","july","degrees Celsius","*degree*C*", +"temperature_min_08","temperature_min_08","WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Aug","min T Aug","august","degrees Celsius","*degree*C*", +"temperature_min_09","temperature_min_09","WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Sep","min T Sep","september","degrees Celsius","*degree*C*", +"temperature_min_10","temperature_min_10","WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Oct","min T Oct","october","degrees Celsius","*degree*C*", +"temperature_min_11","temperature_min_11","WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Nov","min T Nov","november","degrees Celsius","*degree*C*", +"temperature_min_12","temperature_min_12","WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Dec","min T Dec","december","degrees Celsius","*degree*C*", +"temperature_max_01","temperature_max_01","WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jan","max T Jan","january","degrees Celsius","*degree*C*", +"temperature_max_02","temperature_max_02","WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Feb","max T Feb","february","degrees Celsius","*degree*C*", +"temperature_max_03","temperature_max_03","WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Mar","max T Mar","march","degrees Celsius","*degree*C*", +"temperature_max_04","temperature_max_04","WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Apr","max T Apr","april","degrees Celsius","*degree*C*", +"temperature_max_05","temperature_max_05","WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature May","max T May","may","degrees Celsius","*degree*C*", +"temperature_max_06","temperature_max_06","WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jun","max T Jun","june","degrees Celsius","*degree*C*", +"temperature_max_07","temperature_max_07","WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jul","max T Jul","july","degrees Celsius","*degree*C*", +"temperature_max_08","temperature_max_08","WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Aug","max T Aug","august","degrees Celsius","*degree*C*", +"temperature_max_09","temperature_max_09","WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Sep","max T Sep","september","degrees Celsius","*degree*C*", +"temperature_max_10","temperature_max_10","WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Oct","max T Oct","october","degrees Celsius","*degree*C*", +"temperature_max_11","temperature_max_11","WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Nov","max T Nov","november","degrees Celsius","*degree*C*", +"temperature_max_12","temperature_max_12","WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Dec","max T Dec","december","degrees Celsius","*degree*C*", +"bio01","bio01","WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual mean temperature","ann. mean T","year","degrees Celsius","*degree*C*", +"bio02","bio02","WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean diurnal range","diurn. range","year","degrees Celsius","*degree*C*", +"bio03","bio03","WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","isothermality","isothermality","year","","", +"bio04","bio04","WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature seasonality","T season.","year","degrees Celsius","*degree*C*", +"bio05","bio05","WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature of warmest month","max. T of warmest mo.","year","degrees Celsius","*degree*C*", +"bio06","bio06","WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature of coldest month","min. T of coldest mo.","year","degrees Celsius","*degree*C*", +"bio07","bio07","WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature annual range (bio05-bio06)","T ann. Range","year","degrees Celsius","*degree*C*", +"bio08","bio08","WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of wettest quarter","mean T of wettest qtr","year","degrees Celsius","*degree*C*", +"bio09","bio09","WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of driest quarter","mean T of driest qtr","year","degrees Celsius","*degree*C*", +"bio10","bio10","WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of warmest quarter","mean T of warmest qtr","year","degrees Celsius","*degree*C*", +"bio11","bio11","WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of coldest quarter","mean T of coldest qtr","year","degrees Celsius","*degree*C*", +"bio12","bio12","WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual precipitation","ann. P","year","mm per year","*mm~yr^-1*", +"bio13","bio13","WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest month","P of wettest mo.","year","mm per month","*mm~mo^-1*", +"bio14","bio14","WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest month","P of driest mo.","year","mm per month","*mm~mo^-1*", +"bio15","bio15","WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation seasonality (coeff var)","P season.","year","","", +"bio16","bio16","WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest quarter","P of wettest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio17","bio17","WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest quarter","P of driest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio18","bio18","WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of warmest quarter","P of warmest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio19","bio19","WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of coldest quarter","P of coldest qtr","year","mm per quarter","*mm~qtr^-1*", +"precipitation_01","precipitation_01","WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jan","P Jan","january","mm per month","*mm~mo^-1*", +"precipitation_02","precipitation_02","WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Feb","P Feb","february","mm per month","*mm~mo^-1*", +"precipitation_03","precipitation_03","WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Mar","P Mar","march","mm per month","*mm~mo^-1*", +"precipitation_04","precipitation_04","WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Apr","P Apr","april","mm per month","*mm~mo^-1*", +"precipitation_05","precipitation_05","WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation May","P May","may","mm per month","*mm~mo^-1*", +"precipitation_06","precipitation_06","WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jun","P Jun","june","mm per month","*mm~mo^-1*", +"precipitation_07","precipitation_07","WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jul","P Jul","july","mm per month","*mm~mo^-1*", +"precipitation_08","precipitation_08","WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Aug","P Aug","august","mm per month","*mm~mo^-1*", +"precipitation_09","precipitation_09","WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Sep","P Sep","september","mm per month","*mm~mo^-1*", +"precipitation_10","precipitation_10","WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Oct","P Oct","october","mm per month","*mm~mo^-1*", +"precipitation_11","precipitation_11","WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Nov","P Nov","november","mm per month","*mm~mo^-1*", +"precipitation_12","precipitation_12","WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Dec","P Dec","december","mm per month","*mm~mo^-1*", +"temperature_min_01","temperature_min_01","WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jan","min T Jan","january","degrees Celsius","*degree*C*", +"temperature_min_02","temperature_min_02","WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Feb","min T Feb","february","degrees Celsius","*degree*C*", +"temperature_min_03","temperature_min_03","WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Mar","min T Mar","march","degrees Celsius","*degree*C*", +"temperature_min_04","temperature_min_04","WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Apr","min T Apr","april","degrees Celsius","*degree*C*", +"temperature_min_05","temperature_min_05","WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature May","min T May","may","degrees Celsius","*degree*C*", +"temperature_min_06","temperature_min_06","WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jun","min T Jun","june","degrees Celsius","*degree*C*", +"temperature_min_07","temperature_min_07","WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jul","min T Jul","july","degrees Celsius","*degree*C*", +"temperature_min_08","temperature_min_08","WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Aug","min T Aug","august","degrees Celsius","*degree*C*", +"temperature_min_09","temperature_min_09","WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Sep","min T Sep","september","degrees Celsius","*degree*C*", +"temperature_min_10","temperature_min_10","WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Oct","min T Oct","october","degrees Celsius","*degree*C*", +"temperature_min_11","temperature_min_11","WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Nov","min T Nov","november","degrees Celsius","*degree*C*", +"temperature_min_12","temperature_min_12","WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Dec","min T Dec","december","degrees Celsius","*degree*C*", +"temperature_max_01","temperature_max_01","WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jan","max T Jan","january","degrees Celsius","*degree*C*", +"temperature_max_02","temperature_max_02","WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Feb","max T Feb","february","degrees Celsius","*degree*C*", +"temperature_max_03","temperature_max_03","WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Mar","max T Mar","march","degrees Celsius","*degree*C*", +"temperature_max_04","temperature_max_04","WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Apr","max T Apr","april","degrees Celsius","*degree*C*", +"temperature_max_05","temperature_max_05","WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature May","max T May","may","degrees Celsius","*degree*C*", +"temperature_max_06","temperature_max_06","WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jun","max T Jun","june","degrees Celsius","*degree*C*", +"temperature_max_07","temperature_max_07","WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jul","max T Jul","july","degrees Celsius","*degree*C*", +"temperature_max_08","temperature_max_08","WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Aug","max T Aug","august","degrees Celsius","*degree*C*", +"temperature_max_09","temperature_max_09","WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Sep","max T Sep","september","degrees Celsius","*degree*C*", +"temperature_max_10","temperature_max_10","WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Oct","max T Oct","october","degrees Celsius","*degree*C*", +"temperature_max_11","temperature_max_11","WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Nov","max T Nov","november","degrees Celsius","*degree*C*", +"temperature_max_12","temperature_max_12","WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Dec","max T Dec","december","degrees Celsius","*degree*C*", +"bio01","bio01","WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual mean temperature","ann. mean T","year","degrees Celsius","*degree*C*", +"bio02","bio02","WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean diurnal range","diurn. range","year","degrees Celsius","*degree*C*", +"bio03","bio03","WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","isothermality","isothermality","year","","", +"bio04","bio04","WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature seasonality","T season.","year","degrees Celsius","*degree*C*", +"bio05","bio05","WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature of warmest month","max. T of warmest mo.","year","degrees Celsius","*degree*C*", +"bio06","bio06","WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature of coldest month","min. T of coldest mo.","year","degrees Celsius","*degree*C*", +"bio07","bio07","WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature annual range (bio05-bio06)","T ann. Range","year","degrees Celsius","*degree*C*", +"bio08","bio08","WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of wettest quarter","mean T of wettest qtr","year","degrees Celsius","*degree*C*", +"bio09","bio09","WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of driest quarter","mean T of driest qtr","year","degrees Celsius","*degree*C*", +"bio10","bio10","WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of warmest quarter","mean T of warmest qtr","year","degrees Celsius","*degree*C*", +"bio11","bio11","WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of coldest quarter","mean T of coldest qtr","year","degrees Celsius","*degree*C*", +"bio12","bio12","WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual precipitation","ann. P","year","mm per year","*mm~yr^-1*", +"bio13","bio13","WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest month","P of wettest mo.","year","mm per month","*mm~mo^-1*", +"bio14","bio14","WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest month","P of driest mo.","year","mm per month","*mm~mo^-1*", +"bio15","bio15","WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation seasonality (coeff var)","P season.","year","","", +"bio16","bio16","WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest quarter","P of wettest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio17","bio17","WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest quarter","P of driest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio18","bio18","WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of warmest quarter","P of warmest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio19","bio19","WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of coldest quarter","P of coldest qtr","year","mm per quarter","*mm~qtr^-1*", +"precipitation_01","precipitation_01","WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jan","P Jan","january","mm per month","*mm~mo^-1*", +"precipitation_02","precipitation_02","WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Feb","P Feb","february","mm per month","*mm~mo^-1*", +"precipitation_03","precipitation_03","WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Mar","P Mar","march","mm per month","*mm~mo^-1*", +"precipitation_04","precipitation_04","WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Apr","P Apr","april","mm per month","*mm~mo^-1*", +"precipitation_05","precipitation_05","WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation May","P May","may","mm per month","*mm~mo^-1*", +"precipitation_06","precipitation_06","WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jun","P Jun","june","mm per month","*mm~mo^-1*", +"precipitation_07","precipitation_07","WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jul","P Jul","july","mm per month","*mm~mo^-1*", +"precipitation_08","precipitation_08","WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Aug","P Aug","august","mm per month","*mm~mo^-1*", +"precipitation_09","precipitation_09","WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Sep","P Sep","september","mm per month","*mm~mo^-1*", +"precipitation_10","precipitation_10","WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Oct","P Oct","october","mm per month","*mm~mo^-1*", +"precipitation_11","precipitation_11","WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Nov","P Nov","november","mm per month","*mm~mo^-1*", +"precipitation_12","precipitation_12","WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Dec","P Dec","december","mm per month","*mm~mo^-1*", +"temperature_min_01","temperature_min_01","WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jan","min T Jan","january","degrees Celsius","*degree*C*", +"temperature_min_02","temperature_min_02","WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Feb","min T Feb","february","degrees Celsius","*degree*C*", +"temperature_min_03","temperature_min_03","WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Mar","min T Mar","march","degrees Celsius","*degree*C*", +"temperature_min_04","temperature_min_04","WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Apr","min T Apr","april","degrees Celsius","*degree*C*", +"temperature_min_05","temperature_min_05","WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature May","min T May","may","degrees Celsius","*degree*C*", +"temperature_min_06","temperature_min_06","WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jun","min T Jun","june","degrees Celsius","*degree*C*", +"temperature_min_07","temperature_min_07","WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jul","min T Jul","july","degrees Celsius","*degree*C*", +"temperature_min_08","temperature_min_08","WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Aug","min T Aug","august","degrees Celsius","*degree*C*", +"temperature_min_09","temperature_min_09","WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Sep","min T Sep","september","degrees Celsius","*degree*C*", +"temperature_min_10","temperature_min_10","WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Oct","min T Oct","october","degrees Celsius","*degree*C*", +"temperature_min_11","temperature_min_11","WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Nov","min T Nov","november","degrees Celsius","*degree*C*", +"temperature_min_12","temperature_min_12","WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Dec","min T Dec","december","degrees Celsius","*degree*C*", +"temperature_max_01","temperature_max_01","WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jan","max T Jan","january","degrees Celsius","*degree*C*", +"temperature_max_02","temperature_max_02","WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Feb","max T Feb","february","degrees Celsius","*degree*C*", +"temperature_max_03","temperature_max_03","WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Mar","max T Mar","march","degrees Celsius","*degree*C*", +"temperature_max_04","temperature_max_04","WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Apr","max T Apr","april","degrees Celsius","*degree*C*", +"temperature_max_05","temperature_max_05","WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature May","max T May","may","degrees Celsius","*degree*C*", +"temperature_max_06","temperature_max_06","WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jun","max T Jun","june","degrees Celsius","*degree*C*", +"temperature_max_07","temperature_max_07","WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jul","max T Jul","july","degrees Celsius","*degree*C*", +"temperature_max_08","temperature_max_08","WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Aug","max T Aug","august","degrees Celsius","*degree*C*", +"temperature_max_09","temperature_max_09","WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Sep","max T Sep","september","degrees Celsius","*degree*C*", +"temperature_max_10","temperature_max_10","WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Oct","max T Oct","october","degrees Celsius","*degree*C*", +"temperature_max_11","temperature_max_11","WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Nov","max T Nov","november","degrees Celsius","*degree*C*", +"temperature_max_12","temperature_max_12","WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Dec","max T Dec","december","degrees Celsius","*degree*C*", +"bio01","bio01","WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual mean temperature","ann. mean T","year","degrees Celsius","*degree*C*", +"bio02","bio02","WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean diurnal range","diurn. range","year","degrees Celsius","*degree*C*", +"bio03","bio03","WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","isothermality","isothermality","year","","", +"bio04","bio04","WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature seasonality","T season.","year","degrees Celsius","*degree*C*", +"bio05","bio05","WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature of warmest month","max. T of warmest mo.","year","degrees Celsius","*degree*C*", +"bio06","bio06","WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature of coldest month","min. T of coldest mo.","year","degrees Celsius","*degree*C*", +"bio07","bio07","WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature annual range (bio05-bio06)","T ann. Range","year","degrees Celsius","*degree*C*", +"bio08","bio08","WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of wettest quarter","mean T of wettest qtr","year","degrees Celsius","*degree*C*", +"bio09","bio09","WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of driest quarter","mean T of driest qtr","year","degrees Celsius","*degree*C*", +"bio10","bio10","WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of warmest quarter","mean T of warmest qtr","year","degrees Celsius","*degree*C*", +"bio11","bio11","WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of coldest quarter","mean T of coldest qtr","year","degrees Celsius","*degree*C*", +"bio12","bio12","WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual precipitation","ann. P","year","mm per year","*mm~yr^-1*", +"bio13","bio13","WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest month","P of wettest mo.","year","mm per month","*mm~mo^-1*", +"bio14","bio14","WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest month","P of driest mo.","year","mm per month","*mm~mo^-1*", +"bio15","bio15","WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation seasonality (coeff var)","P season.","year","","", +"bio16","bio16","WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest quarter","P of wettest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio17","bio17","WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest quarter","P of driest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio18","bio18","WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of warmest quarter","P of warmest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio19","bio19","WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of coldest quarter","P of coldest qtr","year","mm per quarter","*mm~qtr^-1*", +"precipitation_01","precipitation_01","WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jan","P Jan","january","mm per month","*mm~mo^-1*", +"precipitation_02","precipitation_02","WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Feb","P Feb","february","mm per month","*mm~mo^-1*", +"precipitation_03","precipitation_03","WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Mar","P Mar","march","mm per month","*mm~mo^-1*", +"precipitation_04","precipitation_04","WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Apr","P Apr","april","mm per month","*mm~mo^-1*", +"precipitation_05","precipitation_05","WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation May","P May","may","mm per month","*mm~mo^-1*", +"precipitation_06","precipitation_06","WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jun","P Jun","june","mm per month","*mm~mo^-1*", +"precipitation_07","precipitation_07","WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jul","P Jul","july","mm per month","*mm~mo^-1*", +"precipitation_08","precipitation_08","WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Aug","P Aug","august","mm per month","*mm~mo^-1*", +"precipitation_09","precipitation_09","WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Sep","P Sep","september","mm per month","*mm~mo^-1*", +"precipitation_10","precipitation_10","WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Oct","P Oct","october","mm per month","*mm~mo^-1*", +"precipitation_11","precipitation_11","WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Nov","P Nov","november","mm per month","*mm~mo^-1*", +"precipitation_12","precipitation_12","WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Dec","P Dec","december","mm per month","*mm~mo^-1*", +"temperature_min_01","temperature_min_01","WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jan","min T Jan","january","degrees Celsius","*degree*C*", +"temperature_min_02","temperature_min_02","WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Feb","min T Feb","february","degrees Celsius","*degree*C*", +"temperature_min_03","temperature_min_03","WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Mar","min T Mar","march","degrees Celsius","*degree*C*", +"temperature_min_04","temperature_min_04","WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Apr","min T Apr","april","degrees Celsius","*degree*C*", +"temperature_min_05","temperature_min_05","WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature May","min T May","may","degrees Celsius","*degree*C*", +"temperature_min_06","temperature_min_06","WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jun","min T Jun","june","degrees Celsius","*degree*C*", +"temperature_min_07","temperature_min_07","WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jul","min T Jul","july","degrees Celsius","*degree*C*", +"temperature_min_08","temperature_min_08","WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Aug","min T Aug","august","degrees Celsius","*degree*C*", +"temperature_min_09","temperature_min_09","WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Sep","min T Sep","september","degrees Celsius","*degree*C*", +"temperature_min_10","temperature_min_10","WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Oct","min T Oct","october","degrees Celsius","*degree*C*", +"temperature_min_11","temperature_min_11","WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Nov","min T Nov","november","degrees Celsius","*degree*C*", +"temperature_min_12","temperature_min_12","WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Dec","min T Dec","december","degrees Celsius","*degree*C*", +"temperature_max_01","temperature_max_01","WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jan","max T Jan","january","degrees Celsius","*degree*C*", +"temperature_max_02","temperature_max_02","WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Feb","max T Feb","february","degrees Celsius","*degree*C*", +"temperature_max_03","temperature_max_03","WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Mar","max T Mar","march","degrees Celsius","*degree*C*", +"temperature_max_04","temperature_max_04","WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Apr","max T Apr","april","degrees Celsius","*degree*C*", +"temperature_max_05","temperature_max_05","WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature May","max T May","may","degrees Celsius","*degree*C*", +"temperature_max_06","temperature_max_06","WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jun","max T Jun","june","degrees Celsius","*degree*C*", +"temperature_max_07","temperature_max_07","WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jul","max T Jul","july","degrees Celsius","*degree*C*", +"temperature_max_08","temperature_max_08","WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Aug","max T Aug","august","degrees Celsius","*degree*C*", +"temperature_max_09","temperature_max_09","WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Sep","max T Sep","september","degrees Celsius","*degree*C*", +"temperature_max_10","temperature_max_10","WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Oct","max T Oct","october","degrees Celsius","*degree*C*", +"temperature_max_11","temperature_max_11","WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Nov","max T Nov","november","degrees Celsius","*degree*C*", +"temperature_max_12","temperature_max_12","WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Dec","max T Dec","december","degrees Celsius","*degree*C*", +"bio01","bio01","WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual mean temperature","ann. mean T","year","degrees Celsius","*degree*C*", +"bio02","bio02","WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean diurnal range","diurn. range","year","degrees Celsius","*degree*C*", +"bio03","bio03","WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","isothermality","isothermality","year","","", +"bio04","bio04","WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature seasonality","T season.","year","degrees Celsius","*degree*C*", +"bio05","bio05","WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature of warmest month","max. T of warmest mo.","year","degrees Celsius","*degree*C*", +"bio06","bio06","WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature of coldest month","min. T of coldest mo.","year","degrees Celsius","*degree*C*", +"bio07","bio07","WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature annual range (bio05-bio06)","T ann. Range","year","degrees Celsius","*degree*C*", +"bio08","bio08","WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of wettest quarter","mean T of wettest qtr","year","degrees Celsius","*degree*C*", +"bio09","bio09","WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of driest quarter","mean T of driest qtr","year","degrees Celsius","*degree*C*", +"bio10","bio10","WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of warmest quarter","mean T of warmest qtr","year","degrees Celsius","*degree*C*", +"bio11","bio11","WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of coldest quarter","mean T of coldest qtr","year","degrees Celsius","*degree*C*", +"bio12","bio12","WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual precipitation","ann. P","year","mm per year","*mm~yr^-1*", +"bio13","bio13","WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest month","P of wettest mo.","year","mm per month","*mm~mo^-1*", +"bio14","bio14","WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest month","P of driest mo.","year","mm per month","*mm~mo^-1*", +"bio15","bio15","WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation seasonality (coeff var)","P season.","year","","", +"bio16","bio16","WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest quarter","P of wettest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio17","bio17","WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest quarter","P of driest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio18","bio18","WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of warmest quarter","P of warmest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio19","bio19","WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m",FALSE,"WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of coldest quarter","P of coldest qtr","year","mm per quarter","*mm~qtr^-1*", +"precipitation_01","precipitation_01","WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jan","P Jan","january","mm per month","*mm~mo^-1*", +"precipitation_02","precipitation_02","WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Feb","P Feb","february","mm per month","*mm~mo^-1*", +"precipitation_03","precipitation_03","WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Mar","P Mar","march","mm per month","*mm~mo^-1*", +"precipitation_04","precipitation_04","WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Apr","P Apr","april","mm per month","*mm~mo^-1*", +"precipitation_05","precipitation_05","WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation May","P May","may","mm per month","*mm~mo^-1*", +"precipitation_06","precipitation_06","WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jun","P Jun","june","mm per month","*mm~mo^-1*", +"precipitation_07","precipitation_07","WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jul","P Jul","july","mm per month","*mm~mo^-1*", +"precipitation_08","precipitation_08","WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Aug","P Aug","august","mm per month","*mm~mo^-1*", +"precipitation_09","precipitation_09","WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Sep","P Sep","september","mm per month","*mm~mo^-1*", +"precipitation_10","precipitation_10","WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Oct","P Oct","october","mm per month","*mm~mo^-1*", +"precipitation_11","precipitation_11","WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Nov","P Nov","november","mm per month","*mm~mo^-1*", +"precipitation_12","precipitation_12","WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Dec","P Dec","december","mm per month","*mm~mo^-1*", +"temperature_min_01","temperature_min_01","WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jan","min T Jan","january","degrees Celsius","*degree*C*", +"temperature_min_02","temperature_min_02","WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Feb","min T Feb","february","degrees Celsius","*degree*C*", +"temperature_min_03","temperature_min_03","WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Mar","min T Mar","march","degrees Celsius","*degree*C*", +"temperature_min_04","temperature_min_04","WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Apr","min T Apr","april","degrees Celsius","*degree*C*", +"temperature_min_05","temperature_min_05","WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature May","min T May","may","degrees Celsius","*degree*C*", +"temperature_min_06","temperature_min_06","WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jun","min T Jun","june","degrees Celsius","*degree*C*", +"temperature_min_07","temperature_min_07","WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jul","min T Jul","july","degrees Celsius","*degree*C*", +"temperature_min_08","temperature_min_08","WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Aug","min T Aug","august","degrees Celsius","*degree*C*", +"temperature_min_09","temperature_min_09","WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Sep","min T Sep","september","degrees Celsius","*degree*C*", +"temperature_min_10","temperature_min_10","WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Oct","min T Oct","october","degrees Celsius","*degree*C*", +"temperature_min_11","temperature_min_11","WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Nov","min T Nov","november","degrees Celsius","*degree*C*", +"temperature_min_12","temperature_min_12","WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Dec","min T Dec","december","degrees Celsius","*degree*C*", +"temperature_max_01","temperature_max_01","WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jan","max T Jan","january","degrees Celsius","*degree*C*", +"temperature_max_02","temperature_max_02","WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Feb","max T Feb","february","degrees Celsius","*degree*C*", +"temperature_max_03","temperature_max_03","WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Mar","max T Mar","march","degrees Celsius","*degree*C*", +"temperature_max_04","temperature_max_04","WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Apr","max T Apr","april","degrees Celsius","*degree*C*", +"temperature_max_05","temperature_max_05","WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature May","max T May","may","degrees Celsius","*degree*C*", +"temperature_max_06","temperature_max_06","WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jun","max T Jun","june","degrees Celsius","*degree*C*", +"temperature_max_07","temperature_max_07","WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jul","max T Jul","july","degrees Celsius","*degree*C*", +"temperature_max_08","temperature_max_08","WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Aug","max T Aug","august","degrees Celsius","*degree*C*", +"temperature_max_09","temperature_max_09","WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Sep","max T Sep","september","degrees Celsius","*degree*C*", +"temperature_max_10","temperature_max_10","WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Oct","max T Oct","october","degrees Celsius","*degree*C*", +"temperature_max_11","temperature_max_11","WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Nov","max T Nov","november","degrees Celsius","*degree*C*", +"temperature_max_12","temperature_max_12","WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m",TRUE,"WorldClim_2.1_IPSL-CM6A-LR_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Dec","max T Dec","december","degrees Celsius","*degree*C*", +"bio01","bio01","WorldClim_2.1_MIROC6_ssp126_10m",FALSE,"WorldClim_2.1_MIROC6_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual mean temperature","ann. mean T","year","degrees Celsius","*degree*C*", +"bio02","bio02","WorldClim_2.1_MIROC6_ssp126_10m",FALSE,"WorldClim_2.1_MIROC6_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean diurnal range","diurn. range","year","degrees Celsius","*degree*C*", +"bio03","bio03","WorldClim_2.1_MIROC6_ssp126_10m",FALSE,"WorldClim_2.1_MIROC6_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","isothermality","isothermality","year","","", +"bio04","bio04","WorldClim_2.1_MIROC6_ssp126_10m",FALSE,"WorldClim_2.1_MIROC6_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature seasonality","T season.","year","degrees Celsius","*degree*C*", +"bio05","bio05","WorldClim_2.1_MIROC6_ssp126_10m",FALSE,"WorldClim_2.1_MIROC6_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature of warmest month","max. T of warmest mo.","year","degrees Celsius","*degree*C*", +"bio06","bio06","WorldClim_2.1_MIROC6_ssp126_10m",FALSE,"WorldClim_2.1_MIROC6_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature of coldest month","min. T of coldest mo.","year","degrees Celsius","*degree*C*", +"bio07","bio07","WorldClim_2.1_MIROC6_ssp126_10m",FALSE,"WorldClim_2.1_MIROC6_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature annual range (bio05-bio06)","T ann. Range","year","degrees Celsius","*degree*C*", +"bio08","bio08","WorldClim_2.1_MIROC6_ssp126_10m",FALSE,"WorldClim_2.1_MIROC6_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of wettest quarter","mean T of wettest qtr","year","degrees Celsius","*degree*C*", +"bio09","bio09","WorldClim_2.1_MIROC6_ssp126_10m",FALSE,"WorldClim_2.1_MIROC6_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of driest quarter","mean T of driest qtr","year","degrees Celsius","*degree*C*", +"bio10","bio10","WorldClim_2.1_MIROC6_ssp126_10m",FALSE,"WorldClim_2.1_MIROC6_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of warmest quarter","mean T of warmest qtr","year","degrees Celsius","*degree*C*", +"bio11","bio11","WorldClim_2.1_MIROC6_ssp126_10m",FALSE,"WorldClim_2.1_MIROC6_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of coldest quarter","mean T of coldest qtr","year","degrees Celsius","*degree*C*", +"bio12","bio12","WorldClim_2.1_MIROC6_ssp126_10m",FALSE,"WorldClim_2.1_MIROC6_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual precipitation","ann. P","year","mm per year","*mm~yr^-1*", +"bio13","bio13","WorldClim_2.1_MIROC6_ssp126_10m",FALSE,"WorldClim_2.1_MIROC6_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest month","P of wettest mo.","year","mm per month","*mm~mo^-1*", +"bio14","bio14","WorldClim_2.1_MIROC6_ssp126_10m",FALSE,"WorldClim_2.1_MIROC6_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest month","P of driest mo.","year","mm per month","*mm~mo^-1*", +"bio15","bio15","WorldClim_2.1_MIROC6_ssp126_10m",FALSE,"WorldClim_2.1_MIROC6_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation seasonality (coeff var)","P season.","year","","", +"bio16","bio16","WorldClim_2.1_MIROC6_ssp126_10m",FALSE,"WorldClim_2.1_MIROC6_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest quarter","P of wettest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio17","bio17","WorldClim_2.1_MIROC6_ssp126_10m",FALSE,"WorldClim_2.1_MIROC6_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest quarter","P of driest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio18","bio18","WorldClim_2.1_MIROC6_ssp126_10m",FALSE,"WorldClim_2.1_MIROC6_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of warmest quarter","P of warmest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio19","bio19","WorldClim_2.1_MIROC6_ssp126_10m",FALSE,"WorldClim_2.1_MIROC6_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of coldest quarter","P of coldest qtr","year","mm per quarter","*mm~qtr^-1*", +"precipitation_01","precipitation_01","WorldClim_2.1_MIROC6_ssp126_10m",TRUE,"WorldClim_2.1_MIROC6_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jan","P Jan","january","mm per month","*mm~mo^-1*", +"precipitation_02","precipitation_02","WorldClim_2.1_MIROC6_ssp126_10m",TRUE,"WorldClim_2.1_MIROC6_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Feb","P Feb","february","mm per month","*mm~mo^-1*", +"precipitation_03","precipitation_03","WorldClim_2.1_MIROC6_ssp126_10m",TRUE,"WorldClim_2.1_MIROC6_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Mar","P Mar","march","mm per month","*mm~mo^-1*", +"precipitation_04","precipitation_04","WorldClim_2.1_MIROC6_ssp126_10m",TRUE,"WorldClim_2.1_MIROC6_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Apr","P Apr","april","mm per month","*mm~mo^-1*", +"precipitation_05","precipitation_05","WorldClim_2.1_MIROC6_ssp126_10m",TRUE,"WorldClim_2.1_MIROC6_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation May","P May","may","mm per month","*mm~mo^-1*", +"precipitation_06","precipitation_06","WorldClim_2.1_MIROC6_ssp126_10m",TRUE,"WorldClim_2.1_MIROC6_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jun","P Jun","june","mm per month","*mm~mo^-1*", +"precipitation_07","precipitation_07","WorldClim_2.1_MIROC6_ssp126_10m",TRUE,"WorldClim_2.1_MIROC6_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jul","P Jul","july","mm per month","*mm~mo^-1*", +"precipitation_08","precipitation_08","WorldClim_2.1_MIROC6_ssp126_10m",TRUE,"WorldClim_2.1_MIROC6_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Aug","P Aug","august","mm per month","*mm~mo^-1*", +"precipitation_09","precipitation_09","WorldClim_2.1_MIROC6_ssp126_10m",TRUE,"WorldClim_2.1_MIROC6_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Sep","P Sep","september","mm per month","*mm~mo^-1*", +"precipitation_10","precipitation_10","WorldClim_2.1_MIROC6_ssp126_10m",TRUE,"WorldClim_2.1_MIROC6_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Oct","P Oct","october","mm per month","*mm~mo^-1*", +"precipitation_11","precipitation_11","WorldClim_2.1_MIROC6_ssp126_10m",TRUE,"WorldClim_2.1_MIROC6_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Nov","P Nov","november","mm per month","*mm~mo^-1*", +"precipitation_12","precipitation_12","WorldClim_2.1_MIROC6_ssp126_10m",TRUE,"WorldClim_2.1_MIROC6_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Dec","P Dec","december","mm per month","*mm~mo^-1*", +"temperature_min_01","temperature_min_01","WorldClim_2.1_MIROC6_ssp126_10m",TRUE,"WorldClim_2.1_MIROC6_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jan","min T Jan","january","degrees Celsius","*degree*C*", +"temperature_min_02","temperature_min_02","WorldClim_2.1_MIROC6_ssp126_10m",TRUE,"WorldClim_2.1_MIROC6_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Feb","min T Feb","february","degrees Celsius","*degree*C*", +"temperature_min_03","temperature_min_03","WorldClim_2.1_MIROC6_ssp126_10m",TRUE,"WorldClim_2.1_MIROC6_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Mar","min T Mar","march","degrees Celsius","*degree*C*", +"temperature_min_04","temperature_min_04","WorldClim_2.1_MIROC6_ssp126_10m",TRUE,"WorldClim_2.1_MIROC6_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Apr","min T Apr","april","degrees Celsius","*degree*C*", +"temperature_min_05","temperature_min_05","WorldClim_2.1_MIROC6_ssp126_10m",TRUE,"WorldClim_2.1_MIROC6_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature May","min T May","may","degrees Celsius","*degree*C*", +"temperature_min_06","temperature_min_06","WorldClim_2.1_MIROC6_ssp126_10m",TRUE,"WorldClim_2.1_MIROC6_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jun","min T Jun","june","degrees Celsius","*degree*C*", +"temperature_min_07","temperature_min_07","WorldClim_2.1_MIROC6_ssp126_10m",TRUE,"WorldClim_2.1_MIROC6_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jul","min T Jul","july","degrees Celsius","*degree*C*", +"temperature_min_08","temperature_min_08","WorldClim_2.1_MIROC6_ssp126_10m",TRUE,"WorldClim_2.1_MIROC6_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Aug","min T Aug","august","degrees Celsius","*degree*C*", +"temperature_min_09","temperature_min_09","WorldClim_2.1_MIROC6_ssp126_10m",TRUE,"WorldClim_2.1_MIROC6_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Sep","min T Sep","september","degrees Celsius","*degree*C*", +"temperature_min_10","temperature_min_10","WorldClim_2.1_MIROC6_ssp126_10m",TRUE,"WorldClim_2.1_MIROC6_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Oct","min T Oct","october","degrees Celsius","*degree*C*", +"temperature_min_11","temperature_min_11","WorldClim_2.1_MIROC6_ssp126_10m",TRUE,"WorldClim_2.1_MIROC6_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Nov","min T Nov","november","degrees Celsius","*degree*C*", +"temperature_min_12","temperature_min_12","WorldClim_2.1_MIROC6_ssp126_10m",TRUE,"WorldClim_2.1_MIROC6_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Dec","min T Dec","december","degrees Celsius","*degree*C*", +"temperature_max_01","temperature_max_01","WorldClim_2.1_MIROC6_ssp126_10m",TRUE,"WorldClim_2.1_MIROC6_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jan","max T Jan","january","degrees Celsius","*degree*C*", +"temperature_max_02","temperature_max_02","WorldClim_2.1_MIROC6_ssp126_10m",TRUE,"WorldClim_2.1_MIROC6_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Feb","max T Feb","february","degrees Celsius","*degree*C*", +"temperature_max_03","temperature_max_03","WorldClim_2.1_MIROC6_ssp126_10m",TRUE,"WorldClim_2.1_MIROC6_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Mar","max T Mar","march","degrees Celsius","*degree*C*", +"temperature_max_04","temperature_max_04","WorldClim_2.1_MIROC6_ssp126_10m",TRUE,"WorldClim_2.1_MIROC6_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Apr","max T Apr","april","degrees Celsius","*degree*C*", +"temperature_max_05","temperature_max_05","WorldClim_2.1_MIROC6_ssp126_10m",TRUE,"WorldClim_2.1_MIROC6_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature May","max T May","may","degrees Celsius","*degree*C*", +"temperature_max_06","temperature_max_06","WorldClim_2.1_MIROC6_ssp126_10m",TRUE,"WorldClim_2.1_MIROC6_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jun","max T Jun","june","degrees Celsius","*degree*C*", +"temperature_max_07","temperature_max_07","WorldClim_2.1_MIROC6_ssp126_10m",TRUE,"WorldClim_2.1_MIROC6_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jul","max T Jul","july","degrees Celsius","*degree*C*", +"temperature_max_08","temperature_max_08","WorldClim_2.1_MIROC6_ssp126_10m",TRUE,"WorldClim_2.1_MIROC6_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Aug","max T Aug","august","degrees Celsius","*degree*C*", +"temperature_max_09","temperature_max_09","WorldClim_2.1_MIROC6_ssp126_10m",TRUE,"WorldClim_2.1_MIROC6_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Sep","max T Sep","september","degrees Celsius","*degree*C*", +"temperature_max_10","temperature_max_10","WorldClim_2.1_MIROC6_ssp126_10m",TRUE,"WorldClim_2.1_MIROC6_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Oct","max T Oct","october","degrees Celsius","*degree*C*", +"temperature_max_11","temperature_max_11","WorldClim_2.1_MIROC6_ssp126_10m",TRUE,"WorldClim_2.1_MIROC6_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Nov","max T Nov","november","degrees Celsius","*degree*C*", +"temperature_max_12","temperature_max_12","WorldClim_2.1_MIROC6_ssp126_10m",TRUE,"WorldClim_2.1_MIROC6_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Dec","max T Dec","december","degrees Celsius","*degree*C*", +"bio01","bio01","WorldClim_2.1_MIROC6_ssp126_5m",FALSE,"WorldClim_2.1_MIROC6_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual mean temperature","ann. mean T","year","degrees Celsius","*degree*C*", +"bio02","bio02","WorldClim_2.1_MIROC6_ssp126_5m",FALSE,"WorldClim_2.1_MIROC6_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean diurnal range","diurn. range","year","degrees Celsius","*degree*C*", +"bio03","bio03","WorldClim_2.1_MIROC6_ssp126_5m",FALSE,"WorldClim_2.1_MIROC6_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","isothermality","isothermality","year","","", +"bio04","bio04","WorldClim_2.1_MIROC6_ssp126_5m",FALSE,"WorldClim_2.1_MIROC6_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature seasonality","T season.","year","degrees Celsius","*degree*C*", +"bio05","bio05","WorldClim_2.1_MIROC6_ssp126_5m",FALSE,"WorldClim_2.1_MIROC6_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature of warmest month","max. T of warmest mo.","year","degrees Celsius","*degree*C*", +"bio06","bio06","WorldClim_2.1_MIROC6_ssp126_5m",FALSE,"WorldClim_2.1_MIROC6_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature of coldest month","min. T of coldest mo.","year","degrees Celsius","*degree*C*", +"bio07","bio07","WorldClim_2.1_MIROC6_ssp126_5m",FALSE,"WorldClim_2.1_MIROC6_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature annual range (bio05-bio06)","T ann. Range","year","degrees Celsius","*degree*C*", +"bio08","bio08","WorldClim_2.1_MIROC6_ssp126_5m",FALSE,"WorldClim_2.1_MIROC6_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of wettest quarter","mean T of wettest qtr","year","degrees Celsius","*degree*C*", +"bio09","bio09","WorldClim_2.1_MIROC6_ssp126_5m",FALSE,"WorldClim_2.1_MIROC6_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of driest quarter","mean T of driest qtr","year","degrees Celsius","*degree*C*", +"bio10","bio10","WorldClim_2.1_MIROC6_ssp126_5m",FALSE,"WorldClim_2.1_MIROC6_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of warmest quarter","mean T of warmest qtr","year","degrees Celsius","*degree*C*", +"bio11","bio11","WorldClim_2.1_MIROC6_ssp126_5m",FALSE,"WorldClim_2.1_MIROC6_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of coldest quarter","mean T of coldest qtr","year","degrees Celsius","*degree*C*", +"bio12","bio12","WorldClim_2.1_MIROC6_ssp126_5m",FALSE,"WorldClim_2.1_MIROC6_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual precipitation","ann. P","year","mm per year","*mm~yr^-1*", +"bio13","bio13","WorldClim_2.1_MIROC6_ssp126_5m",FALSE,"WorldClim_2.1_MIROC6_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest month","P of wettest mo.","year","mm per month","*mm~mo^-1*", +"bio14","bio14","WorldClim_2.1_MIROC6_ssp126_5m",FALSE,"WorldClim_2.1_MIROC6_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest month","P of driest mo.","year","mm per month","*mm~mo^-1*", +"bio15","bio15","WorldClim_2.1_MIROC6_ssp126_5m",FALSE,"WorldClim_2.1_MIROC6_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation seasonality (coeff var)","P season.","year","","", +"bio16","bio16","WorldClim_2.1_MIROC6_ssp126_5m",FALSE,"WorldClim_2.1_MIROC6_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest quarter","P of wettest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio17","bio17","WorldClim_2.1_MIROC6_ssp126_5m",FALSE,"WorldClim_2.1_MIROC6_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest quarter","P of driest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio18","bio18","WorldClim_2.1_MIROC6_ssp126_5m",FALSE,"WorldClim_2.1_MIROC6_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of warmest quarter","P of warmest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio19","bio19","WorldClim_2.1_MIROC6_ssp126_5m",FALSE,"WorldClim_2.1_MIROC6_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of coldest quarter","P of coldest qtr","year","mm per quarter","*mm~qtr^-1*", +"precipitation_01","precipitation_01","WorldClim_2.1_MIROC6_ssp126_5m",TRUE,"WorldClim_2.1_MIROC6_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jan","P Jan","january","mm per month","*mm~mo^-1*", +"precipitation_02","precipitation_02","WorldClim_2.1_MIROC6_ssp126_5m",TRUE,"WorldClim_2.1_MIROC6_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Feb","P Feb","february","mm per month","*mm~mo^-1*", +"precipitation_03","precipitation_03","WorldClim_2.1_MIROC6_ssp126_5m",TRUE,"WorldClim_2.1_MIROC6_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Mar","P Mar","march","mm per month","*mm~mo^-1*", +"precipitation_04","precipitation_04","WorldClim_2.1_MIROC6_ssp126_5m",TRUE,"WorldClim_2.1_MIROC6_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Apr","P Apr","april","mm per month","*mm~mo^-1*", +"precipitation_05","precipitation_05","WorldClim_2.1_MIROC6_ssp126_5m",TRUE,"WorldClim_2.1_MIROC6_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation May","P May","may","mm per month","*mm~mo^-1*", +"precipitation_06","precipitation_06","WorldClim_2.1_MIROC6_ssp126_5m",TRUE,"WorldClim_2.1_MIROC6_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jun","P Jun","june","mm per month","*mm~mo^-1*", +"precipitation_07","precipitation_07","WorldClim_2.1_MIROC6_ssp126_5m",TRUE,"WorldClim_2.1_MIROC6_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jul","P Jul","july","mm per month","*mm~mo^-1*", +"precipitation_08","precipitation_08","WorldClim_2.1_MIROC6_ssp126_5m",TRUE,"WorldClim_2.1_MIROC6_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Aug","P Aug","august","mm per month","*mm~mo^-1*", +"precipitation_09","precipitation_09","WorldClim_2.1_MIROC6_ssp126_5m",TRUE,"WorldClim_2.1_MIROC6_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Sep","P Sep","september","mm per month","*mm~mo^-1*", +"precipitation_10","precipitation_10","WorldClim_2.1_MIROC6_ssp126_5m",TRUE,"WorldClim_2.1_MIROC6_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Oct","P Oct","october","mm per month","*mm~mo^-1*", +"precipitation_11","precipitation_11","WorldClim_2.1_MIROC6_ssp126_5m",TRUE,"WorldClim_2.1_MIROC6_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Nov","P Nov","november","mm per month","*mm~mo^-1*", +"precipitation_12","precipitation_12","WorldClim_2.1_MIROC6_ssp126_5m",TRUE,"WorldClim_2.1_MIROC6_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Dec","P Dec","december","mm per month","*mm~mo^-1*", +"temperature_min_01","temperature_min_01","WorldClim_2.1_MIROC6_ssp126_5m",TRUE,"WorldClim_2.1_MIROC6_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jan","min T Jan","january","degrees Celsius","*degree*C*", +"temperature_min_02","temperature_min_02","WorldClim_2.1_MIROC6_ssp126_5m",TRUE,"WorldClim_2.1_MIROC6_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Feb","min T Feb","february","degrees Celsius","*degree*C*", +"temperature_min_03","temperature_min_03","WorldClim_2.1_MIROC6_ssp126_5m",TRUE,"WorldClim_2.1_MIROC6_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Mar","min T Mar","march","degrees Celsius","*degree*C*", +"temperature_min_04","temperature_min_04","WorldClim_2.1_MIROC6_ssp126_5m",TRUE,"WorldClim_2.1_MIROC6_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Apr","min T Apr","april","degrees Celsius","*degree*C*", +"temperature_min_05","temperature_min_05","WorldClim_2.1_MIROC6_ssp126_5m",TRUE,"WorldClim_2.1_MIROC6_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature May","min T May","may","degrees Celsius","*degree*C*", +"temperature_min_06","temperature_min_06","WorldClim_2.1_MIROC6_ssp126_5m",TRUE,"WorldClim_2.1_MIROC6_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jun","min T Jun","june","degrees Celsius","*degree*C*", +"temperature_min_07","temperature_min_07","WorldClim_2.1_MIROC6_ssp126_5m",TRUE,"WorldClim_2.1_MIROC6_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jul","min T Jul","july","degrees Celsius","*degree*C*", +"temperature_min_08","temperature_min_08","WorldClim_2.1_MIROC6_ssp126_5m",TRUE,"WorldClim_2.1_MIROC6_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Aug","min T Aug","august","degrees Celsius","*degree*C*", +"temperature_min_09","temperature_min_09","WorldClim_2.1_MIROC6_ssp126_5m",TRUE,"WorldClim_2.1_MIROC6_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Sep","min T Sep","september","degrees Celsius","*degree*C*", +"temperature_min_10","temperature_min_10","WorldClim_2.1_MIROC6_ssp126_5m",TRUE,"WorldClim_2.1_MIROC6_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Oct","min T Oct","october","degrees Celsius","*degree*C*", +"temperature_min_11","temperature_min_11","WorldClim_2.1_MIROC6_ssp126_5m",TRUE,"WorldClim_2.1_MIROC6_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Nov","min T Nov","november","degrees Celsius","*degree*C*", +"temperature_min_12","temperature_min_12","WorldClim_2.1_MIROC6_ssp126_5m",TRUE,"WorldClim_2.1_MIROC6_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Dec","min T Dec","december","degrees Celsius","*degree*C*", +"temperature_max_01","temperature_max_01","WorldClim_2.1_MIROC6_ssp126_5m",TRUE,"WorldClim_2.1_MIROC6_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jan","max T Jan","january","degrees Celsius","*degree*C*", +"temperature_max_02","temperature_max_02","WorldClim_2.1_MIROC6_ssp126_5m",TRUE,"WorldClim_2.1_MIROC6_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Feb","max T Feb","february","degrees Celsius","*degree*C*", +"temperature_max_03","temperature_max_03","WorldClim_2.1_MIROC6_ssp126_5m",TRUE,"WorldClim_2.1_MIROC6_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Mar","max T Mar","march","degrees Celsius","*degree*C*", +"temperature_max_04","temperature_max_04","WorldClim_2.1_MIROC6_ssp126_5m",TRUE,"WorldClim_2.1_MIROC6_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Apr","max T Apr","april","degrees Celsius","*degree*C*", +"temperature_max_05","temperature_max_05","WorldClim_2.1_MIROC6_ssp126_5m",TRUE,"WorldClim_2.1_MIROC6_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature May","max T May","may","degrees Celsius","*degree*C*", +"temperature_max_06","temperature_max_06","WorldClim_2.1_MIROC6_ssp126_5m",TRUE,"WorldClim_2.1_MIROC6_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jun","max T Jun","june","degrees Celsius","*degree*C*", +"temperature_max_07","temperature_max_07","WorldClim_2.1_MIROC6_ssp126_5m",TRUE,"WorldClim_2.1_MIROC6_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jul","max T Jul","july","degrees Celsius","*degree*C*", +"temperature_max_08","temperature_max_08","WorldClim_2.1_MIROC6_ssp126_5m",TRUE,"WorldClim_2.1_MIROC6_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Aug","max T Aug","august","degrees Celsius","*degree*C*", +"temperature_max_09","temperature_max_09","WorldClim_2.1_MIROC6_ssp126_5m",TRUE,"WorldClim_2.1_MIROC6_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Sep","max T Sep","september","degrees Celsius","*degree*C*", +"temperature_max_10","temperature_max_10","WorldClim_2.1_MIROC6_ssp126_5m",TRUE,"WorldClim_2.1_MIROC6_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Oct","max T Oct","october","degrees Celsius","*degree*C*", +"temperature_max_11","temperature_max_11","WorldClim_2.1_MIROC6_ssp126_5m",TRUE,"WorldClim_2.1_MIROC6_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Nov","max T Nov","november","degrees Celsius","*degree*C*", +"temperature_max_12","temperature_max_12","WorldClim_2.1_MIROC6_ssp126_5m",TRUE,"WorldClim_2.1_MIROC6_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Dec","max T Dec","december","degrees Celsius","*degree*C*", +"bio01","bio01","WorldClim_2.1_MIROC6_ssp245_10m",FALSE,"WorldClim_2.1_MIROC6_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual mean temperature","ann. mean T","year","degrees Celsius","*degree*C*", +"bio02","bio02","WorldClim_2.1_MIROC6_ssp245_10m",FALSE,"WorldClim_2.1_MIROC6_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean diurnal range","diurn. range","year","degrees Celsius","*degree*C*", +"bio03","bio03","WorldClim_2.1_MIROC6_ssp245_10m",FALSE,"WorldClim_2.1_MIROC6_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","isothermality","isothermality","year","","", +"bio04","bio04","WorldClim_2.1_MIROC6_ssp245_10m",FALSE,"WorldClim_2.1_MIROC6_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature seasonality","T season.","year","degrees Celsius","*degree*C*", +"bio05","bio05","WorldClim_2.1_MIROC6_ssp245_10m",FALSE,"WorldClim_2.1_MIROC6_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature of warmest month","max. T of warmest mo.","year","degrees Celsius","*degree*C*", +"bio06","bio06","WorldClim_2.1_MIROC6_ssp245_10m",FALSE,"WorldClim_2.1_MIROC6_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature of coldest month","min. T of coldest mo.","year","degrees Celsius","*degree*C*", +"bio07","bio07","WorldClim_2.1_MIROC6_ssp245_10m",FALSE,"WorldClim_2.1_MIROC6_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature annual range (bio05-bio06)","T ann. Range","year","degrees Celsius","*degree*C*", +"bio08","bio08","WorldClim_2.1_MIROC6_ssp245_10m",FALSE,"WorldClim_2.1_MIROC6_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of wettest quarter","mean T of wettest qtr","year","degrees Celsius","*degree*C*", +"bio09","bio09","WorldClim_2.1_MIROC6_ssp245_10m",FALSE,"WorldClim_2.1_MIROC6_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of driest quarter","mean T of driest qtr","year","degrees Celsius","*degree*C*", +"bio10","bio10","WorldClim_2.1_MIROC6_ssp245_10m",FALSE,"WorldClim_2.1_MIROC6_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of warmest quarter","mean T of warmest qtr","year","degrees Celsius","*degree*C*", +"bio11","bio11","WorldClim_2.1_MIROC6_ssp245_10m",FALSE,"WorldClim_2.1_MIROC6_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of coldest quarter","mean T of coldest qtr","year","degrees Celsius","*degree*C*", +"bio12","bio12","WorldClim_2.1_MIROC6_ssp245_10m",FALSE,"WorldClim_2.1_MIROC6_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual precipitation","ann. P","year","mm per year","*mm~yr^-1*", +"bio13","bio13","WorldClim_2.1_MIROC6_ssp245_10m",FALSE,"WorldClim_2.1_MIROC6_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest month","P of wettest mo.","year","mm per month","*mm~mo^-1*", +"bio14","bio14","WorldClim_2.1_MIROC6_ssp245_10m",FALSE,"WorldClim_2.1_MIROC6_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest month","P of driest mo.","year","mm per month","*mm~mo^-1*", +"bio15","bio15","WorldClim_2.1_MIROC6_ssp245_10m",FALSE,"WorldClim_2.1_MIROC6_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation seasonality (coeff var)","P season.","year","","", +"bio16","bio16","WorldClim_2.1_MIROC6_ssp245_10m",FALSE,"WorldClim_2.1_MIROC6_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest quarter","P of wettest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio17","bio17","WorldClim_2.1_MIROC6_ssp245_10m",FALSE,"WorldClim_2.1_MIROC6_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest quarter","P of driest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio18","bio18","WorldClim_2.1_MIROC6_ssp245_10m",FALSE,"WorldClim_2.1_MIROC6_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of warmest quarter","P of warmest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio19","bio19","WorldClim_2.1_MIROC6_ssp245_10m",FALSE,"WorldClim_2.1_MIROC6_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of coldest quarter","P of coldest qtr","year","mm per quarter","*mm~qtr^-1*", +"precipitation_01","precipitation_01","WorldClim_2.1_MIROC6_ssp245_10m",TRUE,"WorldClim_2.1_MIROC6_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jan","P Jan","january","mm per month","*mm~mo^-1*", +"precipitation_02","precipitation_02","WorldClim_2.1_MIROC6_ssp245_10m",TRUE,"WorldClim_2.1_MIROC6_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Feb","P Feb","february","mm per month","*mm~mo^-1*", +"precipitation_03","precipitation_03","WorldClim_2.1_MIROC6_ssp245_10m",TRUE,"WorldClim_2.1_MIROC6_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Mar","P Mar","march","mm per month","*mm~mo^-1*", +"precipitation_04","precipitation_04","WorldClim_2.1_MIROC6_ssp245_10m",TRUE,"WorldClim_2.1_MIROC6_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Apr","P Apr","april","mm per month","*mm~mo^-1*", +"precipitation_05","precipitation_05","WorldClim_2.1_MIROC6_ssp245_10m",TRUE,"WorldClim_2.1_MIROC6_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation May","P May","may","mm per month","*mm~mo^-1*", +"precipitation_06","precipitation_06","WorldClim_2.1_MIROC6_ssp245_10m",TRUE,"WorldClim_2.1_MIROC6_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jun","P Jun","june","mm per month","*mm~mo^-1*", +"precipitation_07","precipitation_07","WorldClim_2.1_MIROC6_ssp245_10m",TRUE,"WorldClim_2.1_MIROC6_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jul","P Jul","july","mm per month","*mm~mo^-1*", +"precipitation_08","precipitation_08","WorldClim_2.1_MIROC6_ssp245_10m",TRUE,"WorldClim_2.1_MIROC6_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Aug","P Aug","august","mm per month","*mm~mo^-1*", +"precipitation_09","precipitation_09","WorldClim_2.1_MIROC6_ssp245_10m",TRUE,"WorldClim_2.1_MIROC6_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Sep","P Sep","september","mm per month","*mm~mo^-1*", +"precipitation_10","precipitation_10","WorldClim_2.1_MIROC6_ssp245_10m",TRUE,"WorldClim_2.1_MIROC6_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Oct","P Oct","october","mm per month","*mm~mo^-1*", +"precipitation_11","precipitation_11","WorldClim_2.1_MIROC6_ssp245_10m",TRUE,"WorldClim_2.1_MIROC6_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Nov","P Nov","november","mm per month","*mm~mo^-1*", +"precipitation_12","precipitation_12","WorldClim_2.1_MIROC6_ssp245_10m",TRUE,"WorldClim_2.1_MIROC6_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Dec","P Dec","december","mm per month","*mm~mo^-1*", +"temperature_min_01","temperature_min_01","WorldClim_2.1_MIROC6_ssp245_10m",TRUE,"WorldClim_2.1_MIROC6_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jan","min T Jan","january","degrees Celsius","*degree*C*", +"temperature_min_02","temperature_min_02","WorldClim_2.1_MIROC6_ssp245_10m",TRUE,"WorldClim_2.1_MIROC6_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Feb","min T Feb","february","degrees Celsius","*degree*C*", +"temperature_min_03","temperature_min_03","WorldClim_2.1_MIROC6_ssp245_10m",TRUE,"WorldClim_2.1_MIROC6_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Mar","min T Mar","march","degrees Celsius","*degree*C*", +"temperature_min_04","temperature_min_04","WorldClim_2.1_MIROC6_ssp245_10m",TRUE,"WorldClim_2.1_MIROC6_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Apr","min T Apr","april","degrees Celsius","*degree*C*", +"temperature_min_05","temperature_min_05","WorldClim_2.1_MIROC6_ssp245_10m",TRUE,"WorldClim_2.1_MIROC6_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature May","min T May","may","degrees Celsius","*degree*C*", +"temperature_min_06","temperature_min_06","WorldClim_2.1_MIROC6_ssp245_10m",TRUE,"WorldClim_2.1_MIROC6_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jun","min T Jun","june","degrees Celsius","*degree*C*", +"temperature_min_07","temperature_min_07","WorldClim_2.1_MIROC6_ssp245_10m",TRUE,"WorldClim_2.1_MIROC6_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jul","min T Jul","july","degrees Celsius","*degree*C*", +"temperature_min_08","temperature_min_08","WorldClim_2.1_MIROC6_ssp245_10m",TRUE,"WorldClim_2.1_MIROC6_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Aug","min T Aug","august","degrees Celsius","*degree*C*", +"temperature_min_09","temperature_min_09","WorldClim_2.1_MIROC6_ssp245_10m",TRUE,"WorldClim_2.1_MIROC6_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Sep","min T Sep","september","degrees Celsius","*degree*C*", +"temperature_min_10","temperature_min_10","WorldClim_2.1_MIROC6_ssp245_10m",TRUE,"WorldClim_2.1_MIROC6_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Oct","min T Oct","october","degrees Celsius","*degree*C*", +"temperature_min_11","temperature_min_11","WorldClim_2.1_MIROC6_ssp245_10m",TRUE,"WorldClim_2.1_MIROC6_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Nov","min T Nov","november","degrees Celsius","*degree*C*", +"temperature_min_12","temperature_min_12","WorldClim_2.1_MIROC6_ssp245_10m",TRUE,"WorldClim_2.1_MIROC6_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Dec","min T Dec","december","degrees Celsius","*degree*C*", +"temperature_max_01","temperature_max_01","WorldClim_2.1_MIROC6_ssp245_10m",TRUE,"WorldClim_2.1_MIROC6_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jan","max T Jan","january","degrees Celsius","*degree*C*", +"temperature_max_02","temperature_max_02","WorldClim_2.1_MIROC6_ssp245_10m",TRUE,"WorldClim_2.1_MIROC6_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Feb","max T Feb","february","degrees Celsius","*degree*C*", +"temperature_max_03","temperature_max_03","WorldClim_2.1_MIROC6_ssp245_10m",TRUE,"WorldClim_2.1_MIROC6_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Mar","max T Mar","march","degrees Celsius","*degree*C*", +"temperature_max_04","temperature_max_04","WorldClim_2.1_MIROC6_ssp245_10m",TRUE,"WorldClim_2.1_MIROC6_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Apr","max T Apr","april","degrees Celsius","*degree*C*", +"temperature_max_05","temperature_max_05","WorldClim_2.1_MIROC6_ssp245_10m",TRUE,"WorldClim_2.1_MIROC6_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature May","max T May","may","degrees Celsius","*degree*C*", +"temperature_max_06","temperature_max_06","WorldClim_2.1_MIROC6_ssp245_10m",TRUE,"WorldClim_2.1_MIROC6_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jun","max T Jun","june","degrees Celsius","*degree*C*", +"temperature_max_07","temperature_max_07","WorldClim_2.1_MIROC6_ssp245_10m",TRUE,"WorldClim_2.1_MIROC6_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jul","max T Jul","july","degrees Celsius","*degree*C*", +"temperature_max_08","temperature_max_08","WorldClim_2.1_MIROC6_ssp245_10m",TRUE,"WorldClim_2.1_MIROC6_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Aug","max T Aug","august","degrees Celsius","*degree*C*", +"temperature_max_09","temperature_max_09","WorldClim_2.1_MIROC6_ssp245_10m",TRUE,"WorldClim_2.1_MIROC6_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Sep","max T Sep","september","degrees Celsius","*degree*C*", +"temperature_max_10","temperature_max_10","WorldClim_2.1_MIROC6_ssp245_10m",TRUE,"WorldClim_2.1_MIROC6_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Oct","max T Oct","october","degrees Celsius","*degree*C*", +"temperature_max_11","temperature_max_11","WorldClim_2.1_MIROC6_ssp245_10m",TRUE,"WorldClim_2.1_MIROC6_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Nov","max T Nov","november","degrees Celsius","*degree*C*", +"temperature_max_12","temperature_max_12","WorldClim_2.1_MIROC6_ssp245_10m",TRUE,"WorldClim_2.1_MIROC6_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Dec","max T Dec","december","degrees Celsius","*degree*C*", +"bio01","bio01","WorldClim_2.1_MIROC6_ssp245_5m",FALSE,"WorldClim_2.1_MIROC6_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual mean temperature","ann. mean T","year","degrees Celsius","*degree*C*", +"bio02","bio02","WorldClim_2.1_MIROC6_ssp245_5m",FALSE,"WorldClim_2.1_MIROC6_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean diurnal range","diurn. range","year","degrees Celsius","*degree*C*", +"bio03","bio03","WorldClim_2.1_MIROC6_ssp245_5m",FALSE,"WorldClim_2.1_MIROC6_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","isothermality","isothermality","year","","", +"bio04","bio04","WorldClim_2.1_MIROC6_ssp245_5m",FALSE,"WorldClim_2.1_MIROC6_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature seasonality","T season.","year","degrees Celsius","*degree*C*", +"bio05","bio05","WorldClim_2.1_MIROC6_ssp245_5m",FALSE,"WorldClim_2.1_MIROC6_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature of warmest month","max. T of warmest mo.","year","degrees Celsius","*degree*C*", +"bio06","bio06","WorldClim_2.1_MIROC6_ssp245_5m",FALSE,"WorldClim_2.1_MIROC6_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature of coldest month","min. T of coldest mo.","year","degrees Celsius","*degree*C*", +"bio07","bio07","WorldClim_2.1_MIROC6_ssp245_5m",FALSE,"WorldClim_2.1_MIROC6_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature annual range (bio05-bio06)","T ann. Range","year","degrees Celsius","*degree*C*", +"bio08","bio08","WorldClim_2.1_MIROC6_ssp245_5m",FALSE,"WorldClim_2.1_MIROC6_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of wettest quarter","mean T of wettest qtr","year","degrees Celsius","*degree*C*", +"bio09","bio09","WorldClim_2.1_MIROC6_ssp245_5m",FALSE,"WorldClim_2.1_MIROC6_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of driest quarter","mean T of driest qtr","year","degrees Celsius","*degree*C*", +"bio10","bio10","WorldClim_2.1_MIROC6_ssp245_5m",FALSE,"WorldClim_2.1_MIROC6_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of warmest quarter","mean T of warmest qtr","year","degrees Celsius","*degree*C*", +"bio11","bio11","WorldClim_2.1_MIROC6_ssp245_5m",FALSE,"WorldClim_2.1_MIROC6_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of coldest quarter","mean T of coldest qtr","year","degrees Celsius","*degree*C*", +"bio12","bio12","WorldClim_2.1_MIROC6_ssp245_5m",FALSE,"WorldClim_2.1_MIROC6_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual precipitation","ann. P","year","mm per year","*mm~yr^-1*", +"bio13","bio13","WorldClim_2.1_MIROC6_ssp245_5m",FALSE,"WorldClim_2.1_MIROC6_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest month","P of wettest mo.","year","mm per month","*mm~mo^-1*", +"bio14","bio14","WorldClim_2.1_MIROC6_ssp245_5m",FALSE,"WorldClim_2.1_MIROC6_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest month","P of driest mo.","year","mm per month","*mm~mo^-1*", +"bio15","bio15","WorldClim_2.1_MIROC6_ssp245_5m",FALSE,"WorldClim_2.1_MIROC6_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation seasonality (coeff var)","P season.","year","","", +"bio16","bio16","WorldClim_2.1_MIROC6_ssp245_5m",FALSE,"WorldClim_2.1_MIROC6_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest quarter","P of wettest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio17","bio17","WorldClim_2.1_MIROC6_ssp245_5m",FALSE,"WorldClim_2.1_MIROC6_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest quarter","P of driest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio18","bio18","WorldClim_2.1_MIROC6_ssp245_5m",FALSE,"WorldClim_2.1_MIROC6_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of warmest quarter","P of warmest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio19","bio19","WorldClim_2.1_MIROC6_ssp245_5m",FALSE,"WorldClim_2.1_MIROC6_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of coldest quarter","P of coldest qtr","year","mm per quarter","*mm~qtr^-1*", +"precipitation_01","precipitation_01","WorldClim_2.1_MIROC6_ssp245_5m",TRUE,"WorldClim_2.1_MIROC6_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jan","P Jan","january","mm per month","*mm~mo^-1*", +"precipitation_02","precipitation_02","WorldClim_2.1_MIROC6_ssp245_5m",TRUE,"WorldClim_2.1_MIROC6_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Feb","P Feb","february","mm per month","*mm~mo^-1*", +"precipitation_03","precipitation_03","WorldClim_2.1_MIROC6_ssp245_5m",TRUE,"WorldClim_2.1_MIROC6_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Mar","P Mar","march","mm per month","*mm~mo^-1*", +"precipitation_04","precipitation_04","WorldClim_2.1_MIROC6_ssp245_5m",TRUE,"WorldClim_2.1_MIROC6_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Apr","P Apr","april","mm per month","*mm~mo^-1*", +"precipitation_05","precipitation_05","WorldClim_2.1_MIROC6_ssp245_5m",TRUE,"WorldClim_2.1_MIROC6_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation May","P May","may","mm per month","*mm~mo^-1*", +"precipitation_06","precipitation_06","WorldClim_2.1_MIROC6_ssp245_5m",TRUE,"WorldClim_2.1_MIROC6_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jun","P Jun","june","mm per month","*mm~mo^-1*", +"precipitation_07","precipitation_07","WorldClim_2.1_MIROC6_ssp245_5m",TRUE,"WorldClim_2.1_MIROC6_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jul","P Jul","july","mm per month","*mm~mo^-1*", +"precipitation_08","precipitation_08","WorldClim_2.1_MIROC6_ssp245_5m",TRUE,"WorldClim_2.1_MIROC6_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Aug","P Aug","august","mm per month","*mm~mo^-1*", +"precipitation_09","precipitation_09","WorldClim_2.1_MIROC6_ssp245_5m",TRUE,"WorldClim_2.1_MIROC6_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Sep","P Sep","september","mm per month","*mm~mo^-1*", +"precipitation_10","precipitation_10","WorldClim_2.1_MIROC6_ssp245_5m",TRUE,"WorldClim_2.1_MIROC6_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Oct","P Oct","october","mm per month","*mm~mo^-1*", +"precipitation_11","precipitation_11","WorldClim_2.1_MIROC6_ssp245_5m",TRUE,"WorldClim_2.1_MIROC6_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Nov","P Nov","november","mm per month","*mm~mo^-1*", +"precipitation_12","precipitation_12","WorldClim_2.1_MIROC6_ssp245_5m",TRUE,"WorldClim_2.1_MIROC6_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Dec","P Dec","december","mm per month","*mm~mo^-1*", +"temperature_min_01","temperature_min_01","WorldClim_2.1_MIROC6_ssp245_5m",TRUE,"WorldClim_2.1_MIROC6_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jan","min T Jan","january","degrees Celsius","*degree*C*", +"temperature_min_02","temperature_min_02","WorldClim_2.1_MIROC6_ssp245_5m",TRUE,"WorldClim_2.1_MIROC6_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Feb","min T Feb","february","degrees Celsius","*degree*C*", +"temperature_min_03","temperature_min_03","WorldClim_2.1_MIROC6_ssp245_5m",TRUE,"WorldClim_2.1_MIROC6_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Mar","min T Mar","march","degrees Celsius","*degree*C*", +"temperature_min_04","temperature_min_04","WorldClim_2.1_MIROC6_ssp245_5m",TRUE,"WorldClim_2.1_MIROC6_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Apr","min T Apr","april","degrees Celsius","*degree*C*", +"temperature_min_05","temperature_min_05","WorldClim_2.1_MIROC6_ssp245_5m",TRUE,"WorldClim_2.1_MIROC6_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature May","min T May","may","degrees Celsius","*degree*C*", +"temperature_min_06","temperature_min_06","WorldClim_2.1_MIROC6_ssp245_5m",TRUE,"WorldClim_2.1_MIROC6_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jun","min T Jun","june","degrees Celsius","*degree*C*", +"temperature_min_07","temperature_min_07","WorldClim_2.1_MIROC6_ssp245_5m",TRUE,"WorldClim_2.1_MIROC6_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jul","min T Jul","july","degrees Celsius","*degree*C*", +"temperature_min_08","temperature_min_08","WorldClim_2.1_MIROC6_ssp245_5m",TRUE,"WorldClim_2.1_MIROC6_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Aug","min T Aug","august","degrees Celsius","*degree*C*", +"temperature_min_09","temperature_min_09","WorldClim_2.1_MIROC6_ssp245_5m",TRUE,"WorldClim_2.1_MIROC6_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Sep","min T Sep","september","degrees Celsius","*degree*C*", +"temperature_min_10","temperature_min_10","WorldClim_2.1_MIROC6_ssp245_5m",TRUE,"WorldClim_2.1_MIROC6_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Oct","min T Oct","october","degrees Celsius","*degree*C*", +"temperature_min_11","temperature_min_11","WorldClim_2.1_MIROC6_ssp245_5m",TRUE,"WorldClim_2.1_MIROC6_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Nov","min T Nov","november","degrees Celsius","*degree*C*", +"temperature_min_12","temperature_min_12","WorldClim_2.1_MIROC6_ssp245_5m",TRUE,"WorldClim_2.1_MIROC6_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Dec","min T Dec","december","degrees Celsius","*degree*C*", +"temperature_max_01","temperature_max_01","WorldClim_2.1_MIROC6_ssp245_5m",TRUE,"WorldClim_2.1_MIROC6_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jan","max T Jan","january","degrees Celsius","*degree*C*", +"temperature_max_02","temperature_max_02","WorldClim_2.1_MIROC6_ssp245_5m",TRUE,"WorldClim_2.1_MIROC6_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Feb","max T Feb","february","degrees Celsius","*degree*C*", +"temperature_max_03","temperature_max_03","WorldClim_2.1_MIROC6_ssp245_5m",TRUE,"WorldClim_2.1_MIROC6_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Mar","max T Mar","march","degrees Celsius","*degree*C*", +"temperature_max_04","temperature_max_04","WorldClim_2.1_MIROC6_ssp245_5m",TRUE,"WorldClim_2.1_MIROC6_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Apr","max T Apr","april","degrees Celsius","*degree*C*", +"temperature_max_05","temperature_max_05","WorldClim_2.1_MIROC6_ssp245_5m",TRUE,"WorldClim_2.1_MIROC6_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature May","max T May","may","degrees Celsius","*degree*C*", +"temperature_max_06","temperature_max_06","WorldClim_2.1_MIROC6_ssp245_5m",TRUE,"WorldClim_2.1_MIROC6_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jun","max T Jun","june","degrees Celsius","*degree*C*", +"temperature_max_07","temperature_max_07","WorldClim_2.1_MIROC6_ssp245_5m",TRUE,"WorldClim_2.1_MIROC6_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jul","max T Jul","july","degrees Celsius","*degree*C*", +"temperature_max_08","temperature_max_08","WorldClim_2.1_MIROC6_ssp245_5m",TRUE,"WorldClim_2.1_MIROC6_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Aug","max T Aug","august","degrees Celsius","*degree*C*", +"temperature_max_09","temperature_max_09","WorldClim_2.1_MIROC6_ssp245_5m",TRUE,"WorldClim_2.1_MIROC6_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Sep","max T Sep","september","degrees Celsius","*degree*C*", +"temperature_max_10","temperature_max_10","WorldClim_2.1_MIROC6_ssp245_5m",TRUE,"WorldClim_2.1_MIROC6_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Oct","max T Oct","october","degrees Celsius","*degree*C*", +"temperature_max_11","temperature_max_11","WorldClim_2.1_MIROC6_ssp245_5m",TRUE,"WorldClim_2.1_MIROC6_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Nov","max T Nov","november","degrees Celsius","*degree*C*", +"temperature_max_12","temperature_max_12","WorldClim_2.1_MIROC6_ssp245_5m",TRUE,"WorldClim_2.1_MIROC6_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Dec","max T Dec","december","degrees Celsius","*degree*C*", +"bio01","bio01","WorldClim_2.1_MIROC6_ssp370_10m",FALSE,"WorldClim_2.1_MIROC6_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual mean temperature","ann. mean T","year","degrees Celsius","*degree*C*", +"bio02","bio02","WorldClim_2.1_MIROC6_ssp370_10m",FALSE,"WorldClim_2.1_MIROC6_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean diurnal range","diurn. range","year","degrees Celsius","*degree*C*", +"bio03","bio03","WorldClim_2.1_MIROC6_ssp370_10m",FALSE,"WorldClim_2.1_MIROC6_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","isothermality","isothermality","year","","", +"bio04","bio04","WorldClim_2.1_MIROC6_ssp370_10m",FALSE,"WorldClim_2.1_MIROC6_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature seasonality","T season.","year","degrees Celsius","*degree*C*", +"bio05","bio05","WorldClim_2.1_MIROC6_ssp370_10m",FALSE,"WorldClim_2.1_MIROC6_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature of warmest month","max. T of warmest mo.","year","degrees Celsius","*degree*C*", +"bio06","bio06","WorldClim_2.1_MIROC6_ssp370_10m",FALSE,"WorldClim_2.1_MIROC6_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature of coldest month","min. T of coldest mo.","year","degrees Celsius","*degree*C*", +"bio07","bio07","WorldClim_2.1_MIROC6_ssp370_10m",FALSE,"WorldClim_2.1_MIROC6_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature annual range (bio05-bio06)","T ann. Range","year","degrees Celsius","*degree*C*", +"bio08","bio08","WorldClim_2.1_MIROC6_ssp370_10m",FALSE,"WorldClim_2.1_MIROC6_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of wettest quarter","mean T of wettest qtr","year","degrees Celsius","*degree*C*", +"bio09","bio09","WorldClim_2.1_MIROC6_ssp370_10m",FALSE,"WorldClim_2.1_MIROC6_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of driest quarter","mean T of driest qtr","year","degrees Celsius","*degree*C*", +"bio10","bio10","WorldClim_2.1_MIROC6_ssp370_10m",FALSE,"WorldClim_2.1_MIROC6_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of warmest quarter","mean T of warmest qtr","year","degrees Celsius","*degree*C*", +"bio11","bio11","WorldClim_2.1_MIROC6_ssp370_10m",FALSE,"WorldClim_2.1_MIROC6_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of coldest quarter","mean T of coldest qtr","year","degrees Celsius","*degree*C*", +"bio12","bio12","WorldClim_2.1_MIROC6_ssp370_10m",FALSE,"WorldClim_2.1_MIROC6_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual precipitation","ann. P","year","mm per year","*mm~yr^-1*", +"bio13","bio13","WorldClim_2.1_MIROC6_ssp370_10m",FALSE,"WorldClim_2.1_MIROC6_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest month","P of wettest mo.","year","mm per month","*mm~mo^-1*", +"bio14","bio14","WorldClim_2.1_MIROC6_ssp370_10m",FALSE,"WorldClim_2.1_MIROC6_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest month","P of driest mo.","year","mm per month","*mm~mo^-1*", +"bio15","bio15","WorldClim_2.1_MIROC6_ssp370_10m",FALSE,"WorldClim_2.1_MIROC6_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation seasonality (coeff var)","P season.","year","","", +"bio16","bio16","WorldClim_2.1_MIROC6_ssp370_10m",FALSE,"WorldClim_2.1_MIROC6_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest quarter","P of wettest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio17","bio17","WorldClim_2.1_MIROC6_ssp370_10m",FALSE,"WorldClim_2.1_MIROC6_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest quarter","P of driest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio18","bio18","WorldClim_2.1_MIROC6_ssp370_10m",FALSE,"WorldClim_2.1_MIROC6_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of warmest quarter","P of warmest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio19","bio19","WorldClim_2.1_MIROC6_ssp370_10m",FALSE,"WorldClim_2.1_MIROC6_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of coldest quarter","P of coldest qtr","year","mm per quarter","*mm~qtr^-1*", +"precipitation_01","precipitation_01","WorldClim_2.1_MIROC6_ssp370_10m",TRUE,"WorldClim_2.1_MIROC6_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jan","P Jan","january","mm per month","*mm~mo^-1*", +"precipitation_02","precipitation_02","WorldClim_2.1_MIROC6_ssp370_10m",TRUE,"WorldClim_2.1_MIROC6_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Feb","P Feb","february","mm per month","*mm~mo^-1*", +"precipitation_03","precipitation_03","WorldClim_2.1_MIROC6_ssp370_10m",TRUE,"WorldClim_2.1_MIROC6_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Mar","P Mar","march","mm per month","*mm~mo^-1*", +"precipitation_04","precipitation_04","WorldClim_2.1_MIROC6_ssp370_10m",TRUE,"WorldClim_2.1_MIROC6_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Apr","P Apr","april","mm per month","*mm~mo^-1*", +"precipitation_05","precipitation_05","WorldClim_2.1_MIROC6_ssp370_10m",TRUE,"WorldClim_2.1_MIROC6_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation May","P May","may","mm per month","*mm~mo^-1*", +"precipitation_06","precipitation_06","WorldClim_2.1_MIROC6_ssp370_10m",TRUE,"WorldClim_2.1_MIROC6_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jun","P Jun","june","mm per month","*mm~mo^-1*", +"precipitation_07","precipitation_07","WorldClim_2.1_MIROC6_ssp370_10m",TRUE,"WorldClim_2.1_MIROC6_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jul","P Jul","july","mm per month","*mm~mo^-1*", +"precipitation_08","precipitation_08","WorldClim_2.1_MIROC6_ssp370_10m",TRUE,"WorldClim_2.1_MIROC6_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Aug","P Aug","august","mm per month","*mm~mo^-1*", +"precipitation_09","precipitation_09","WorldClim_2.1_MIROC6_ssp370_10m",TRUE,"WorldClim_2.1_MIROC6_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Sep","P Sep","september","mm per month","*mm~mo^-1*", +"precipitation_10","precipitation_10","WorldClim_2.1_MIROC6_ssp370_10m",TRUE,"WorldClim_2.1_MIROC6_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Oct","P Oct","october","mm per month","*mm~mo^-1*", +"precipitation_11","precipitation_11","WorldClim_2.1_MIROC6_ssp370_10m",TRUE,"WorldClim_2.1_MIROC6_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Nov","P Nov","november","mm per month","*mm~mo^-1*", +"precipitation_12","precipitation_12","WorldClim_2.1_MIROC6_ssp370_10m",TRUE,"WorldClim_2.1_MIROC6_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Dec","P Dec","december","mm per month","*mm~mo^-1*", +"temperature_min_01","temperature_min_01","WorldClim_2.1_MIROC6_ssp370_10m",TRUE,"WorldClim_2.1_MIROC6_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jan","min T Jan","january","degrees Celsius","*degree*C*", +"temperature_min_02","temperature_min_02","WorldClim_2.1_MIROC6_ssp370_10m",TRUE,"WorldClim_2.1_MIROC6_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Feb","min T Feb","february","degrees Celsius","*degree*C*", +"temperature_min_03","temperature_min_03","WorldClim_2.1_MIROC6_ssp370_10m",TRUE,"WorldClim_2.1_MIROC6_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Mar","min T Mar","march","degrees Celsius","*degree*C*", +"temperature_min_04","temperature_min_04","WorldClim_2.1_MIROC6_ssp370_10m",TRUE,"WorldClim_2.1_MIROC6_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Apr","min T Apr","april","degrees Celsius","*degree*C*", +"temperature_min_05","temperature_min_05","WorldClim_2.1_MIROC6_ssp370_10m",TRUE,"WorldClim_2.1_MIROC6_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature May","min T May","may","degrees Celsius","*degree*C*", +"temperature_min_06","temperature_min_06","WorldClim_2.1_MIROC6_ssp370_10m",TRUE,"WorldClim_2.1_MIROC6_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jun","min T Jun","june","degrees Celsius","*degree*C*", +"temperature_min_07","temperature_min_07","WorldClim_2.1_MIROC6_ssp370_10m",TRUE,"WorldClim_2.1_MIROC6_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jul","min T Jul","july","degrees Celsius","*degree*C*", +"temperature_min_08","temperature_min_08","WorldClim_2.1_MIROC6_ssp370_10m",TRUE,"WorldClim_2.1_MIROC6_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Aug","min T Aug","august","degrees Celsius","*degree*C*", +"temperature_min_09","temperature_min_09","WorldClim_2.1_MIROC6_ssp370_10m",TRUE,"WorldClim_2.1_MIROC6_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Sep","min T Sep","september","degrees Celsius","*degree*C*", +"temperature_min_10","temperature_min_10","WorldClim_2.1_MIROC6_ssp370_10m",TRUE,"WorldClim_2.1_MIROC6_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Oct","min T Oct","october","degrees Celsius","*degree*C*", +"temperature_min_11","temperature_min_11","WorldClim_2.1_MIROC6_ssp370_10m",TRUE,"WorldClim_2.1_MIROC6_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Nov","min T Nov","november","degrees Celsius","*degree*C*", +"temperature_min_12","temperature_min_12","WorldClim_2.1_MIROC6_ssp370_10m",TRUE,"WorldClim_2.1_MIROC6_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Dec","min T Dec","december","degrees Celsius","*degree*C*", +"temperature_max_01","temperature_max_01","WorldClim_2.1_MIROC6_ssp370_10m",TRUE,"WorldClim_2.1_MIROC6_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jan","max T Jan","january","degrees Celsius","*degree*C*", +"temperature_max_02","temperature_max_02","WorldClim_2.1_MIROC6_ssp370_10m",TRUE,"WorldClim_2.1_MIROC6_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Feb","max T Feb","february","degrees Celsius","*degree*C*", +"temperature_max_03","temperature_max_03","WorldClim_2.1_MIROC6_ssp370_10m",TRUE,"WorldClim_2.1_MIROC6_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Mar","max T Mar","march","degrees Celsius","*degree*C*", +"temperature_max_04","temperature_max_04","WorldClim_2.1_MIROC6_ssp370_10m",TRUE,"WorldClim_2.1_MIROC6_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Apr","max T Apr","april","degrees Celsius","*degree*C*", +"temperature_max_05","temperature_max_05","WorldClim_2.1_MIROC6_ssp370_10m",TRUE,"WorldClim_2.1_MIROC6_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature May","max T May","may","degrees Celsius","*degree*C*", +"temperature_max_06","temperature_max_06","WorldClim_2.1_MIROC6_ssp370_10m",TRUE,"WorldClim_2.1_MIROC6_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jun","max T Jun","june","degrees Celsius","*degree*C*", +"temperature_max_07","temperature_max_07","WorldClim_2.1_MIROC6_ssp370_10m",TRUE,"WorldClim_2.1_MIROC6_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jul","max T Jul","july","degrees Celsius","*degree*C*", +"temperature_max_08","temperature_max_08","WorldClim_2.1_MIROC6_ssp370_10m",TRUE,"WorldClim_2.1_MIROC6_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Aug","max T Aug","august","degrees Celsius","*degree*C*", +"temperature_max_09","temperature_max_09","WorldClim_2.1_MIROC6_ssp370_10m",TRUE,"WorldClim_2.1_MIROC6_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Sep","max T Sep","september","degrees Celsius","*degree*C*", +"temperature_max_10","temperature_max_10","WorldClim_2.1_MIROC6_ssp370_10m",TRUE,"WorldClim_2.1_MIROC6_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Oct","max T Oct","october","degrees Celsius","*degree*C*", +"temperature_max_11","temperature_max_11","WorldClim_2.1_MIROC6_ssp370_10m",TRUE,"WorldClim_2.1_MIROC6_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Nov","max T Nov","november","degrees Celsius","*degree*C*", +"temperature_max_12","temperature_max_12","WorldClim_2.1_MIROC6_ssp370_10m",TRUE,"WorldClim_2.1_MIROC6_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Dec","max T Dec","december","degrees Celsius","*degree*C*", +"bio01","bio01","WorldClim_2.1_MIROC6_ssp370_5m",FALSE,"WorldClim_2.1_MIROC6_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual mean temperature","ann. mean T","year","degrees Celsius","*degree*C*", +"bio02","bio02","WorldClim_2.1_MIROC6_ssp370_5m",FALSE,"WorldClim_2.1_MIROC6_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean diurnal range","diurn. range","year","degrees Celsius","*degree*C*", +"bio03","bio03","WorldClim_2.1_MIROC6_ssp370_5m",FALSE,"WorldClim_2.1_MIROC6_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","isothermality","isothermality","year","","", +"bio04","bio04","WorldClim_2.1_MIROC6_ssp370_5m",FALSE,"WorldClim_2.1_MIROC6_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature seasonality","T season.","year","degrees Celsius","*degree*C*", +"bio05","bio05","WorldClim_2.1_MIROC6_ssp370_5m",FALSE,"WorldClim_2.1_MIROC6_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature of warmest month","max. T of warmest mo.","year","degrees Celsius","*degree*C*", +"bio06","bio06","WorldClim_2.1_MIROC6_ssp370_5m",FALSE,"WorldClim_2.1_MIROC6_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature of coldest month","min. T of coldest mo.","year","degrees Celsius","*degree*C*", +"bio07","bio07","WorldClim_2.1_MIROC6_ssp370_5m",FALSE,"WorldClim_2.1_MIROC6_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature annual range (bio05-bio06)","T ann. Range","year","degrees Celsius","*degree*C*", +"bio08","bio08","WorldClim_2.1_MIROC6_ssp370_5m",FALSE,"WorldClim_2.1_MIROC6_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of wettest quarter","mean T of wettest qtr","year","degrees Celsius","*degree*C*", +"bio09","bio09","WorldClim_2.1_MIROC6_ssp370_5m",FALSE,"WorldClim_2.1_MIROC6_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of driest quarter","mean T of driest qtr","year","degrees Celsius","*degree*C*", +"bio10","bio10","WorldClim_2.1_MIROC6_ssp370_5m",FALSE,"WorldClim_2.1_MIROC6_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of warmest quarter","mean T of warmest qtr","year","degrees Celsius","*degree*C*", +"bio11","bio11","WorldClim_2.1_MIROC6_ssp370_5m",FALSE,"WorldClim_2.1_MIROC6_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of coldest quarter","mean T of coldest qtr","year","degrees Celsius","*degree*C*", +"bio12","bio12","WorldClim_2.1_MIROC6_ssp370_5m",FALSE,"WorldClim_2.1_MIROC6_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual precipitation","ann. P","year","mm per year","*mm~yr^-1*", +"bio13","bio13","WorldClim_2.1_MIROC6_ssp370_5m",FALSE,"WorldClim_2.1_MIROC6_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest month","P of wettest mo.","year","mm per month","*mm~mo^-1*", +"bio14","bio14","WorldClim_2.1_MIROC6_ssp370_5m",FALSE,"WorldClim_2.1_MIROC6_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest month","P of driest mo.","year","mm per month","*mm~mo^-1*", +"bio15","bio15","WorldClim_2.1_MIROC6_ssp370_5m",FALSE,"WorldClim_2.1_MIROC6_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation seasonality (coeff var)","P season.","year","","", +"bio16","bio16","WorldClim_2.1_MIROC6_ssp370_5m",FALSE,"WorldClim_2.1_MIROC6_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest quarter","P of wettest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio17","bio17","WorldClim_2.1_MIROC6_ssp370_5m",FALSE,"WorldClim_2.1_MIROC6_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest quarter","P of driest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio18","bio18","WorldClim_2.1_MIROC6_ssp370_5m",FALSE,"WorldClim_2.1_MIROC6_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of warmest quarter","P of warmest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio19","bio19","WorldClim_2.1_MIROC6_ssp370_5m",FALSE,"WorldClim_2.1_MIROC6_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of coldest quarter","P of coldest qtr","year","mm per quarter","*mm~qtr^-1*", +"precipitation_01","precipitation_01","WorldClim_2.1_MIROC6_ssp370_5m",TRUE,"WorldClim_2.1_MIROC6_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jan","P Jan","january","mm per month","*mm~mo^-1*", +"precipitation_02","precipitation_02","WorldClim_2.1_MIROC6_ssp370_5m",TRUE,"WorldClim_2.1_MIROC6_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Feb","P Feb","february","mm per month","*mm~mo^-1*", +"precipitation_03","precipitation_03","WorldClim_2.1_MIROC6_ssp370_5m",TRUE,"WorldClim_2.1_MIROC6_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Mar","P Mar","march","mm per month","*mm~mo^-1*", +"precipitation_04","precipitation_04","WorldClim_2.1_MIROC6_ssp370_5m",TRUE,"WorldClim_2.1_MIROC6_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Apr","P Apr","april","mm per month","*mm~mo^-1*", +"precipitation_05","precipitation_05","WorldClim_2.1_MIROC6_ssp370_5m",TRUE,"WorldClim_2.1_MIROC6_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation May","P May","may","mm per month","*mm~mo^-1*", +"precipitation_06","precipitation_06","WorldClim_2.1_MIROC6_ssp370_5m",TRUE,"WorldClim_2.1_MIROC6_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jun","P Jun","june","mm per month","*mm~mo^-1*", +"precipitation_07","precipitation_07","WorldClim_2.1_MIROC6_ssp370_5m",TRUE,"WorldClim_2.1_MIROC6_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jul","P Jul","july","mm per month","*mm~mo^-1*", +"precipitation_08","precipitation_08","WorldClim_2.1_MIROC6_ssp370_5m",TRUE,"WorldClim_2.1_MIROC6_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Aug","P Aug","august","mm per month","*mm~mo^-1*", +"precipitation_09","precipitation_09","WorldClim_2.1_MIROC6_ssp370_5m",TRUE,"WorldClim_2.1_MIROC6_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Sep","P Sep","september","mm per month","*mm~mo^-1*", +"precipitation_10","precipitation_10","WorldClim_2.1_MIROC6_ssp370_5m",TRUE,"WorldClim_2.1_MIROC6_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Oct","P Oct","october","mm per month","*mm~mo^-1*", +"precipitation_11","precipitation_11","WorldClim_2.1_MIROC6_ssp370_5m",TRUE,"WorldClim_2.1_MIROC6_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Nov","P Nov","november","mm per month","*mm~mo^-1*", +"precipitation_12","precipitation_12","WorldClim_2.1_MIROC6_ssp370_5m",TRUE,"WorldClim_2.1_MIROC6_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Dec","P Dec","december","mm per month","*mm~mo^-1*", +"temperature_min_01","temperature_min_01","WorldClim_2.1_MIROC6_ssp370_5m",TRUE,"WorldClim_2.1_MIROC6_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jan","min T Jan","january","degrees Celsius","*degree*C*", +"temperature_min_02","temperature_min_02","WorldClim_2.1_MIROC6_ssp370_5m",TRUE,"WorldClim_2.1_MIROC6_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Feb","min T Feb","february","degrees Celsius","*degree*C*", +"temperature_min_03","temperature_min_03","WorldClim_2.1_MIROC6_ssp370_5m",TRUE,"WorldClim_2.1_MIROC6_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Mar","min T Mar","march","degrees Celsius","*degree*C*", +"temperature_min_04","temperature_min_04","WorldClim_2.1_MIROC6_ssp370_5m",TRUE,"WorldClim_2.1_MIROC6_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Apr","min T Apr","april","degrees Celsius","*degree*C*", +"temperature_min_05","temperature_min_05","WorldClim_2.1_MIROC6_ssp370_5m",TRUE,"WorldClim_2.1_MIROC6_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature May","min T May","may","degrees Celsius","*degree*C*", +"temperature_min_06","temperature_min_06","WorldClim_2.1_MIROC6_ssp370_5m",TRUE,"WorldClim_2.1_MIROC6_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jun","min T Jun","june","degrees Celsius","*degree*C*", +"temperature_min_07","temperature_min_07","WorldClim_2.1_MIROC6_ssp370_5m",TRUE,"WorldClim_2.1_MIROC6_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jul","min T Jul","july","degrees Celsius","*degree*C*", +"temperature_min_08","temperature_min_08","WorldClim_2.1_MIROC6_ssp370_5m",TRUE,"WorldClim_2.1_MIROC6_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Aug","min T Aug","august","degrees Celsius","*degree*C*", +"temperature_min_09","temperature_min_09","WorldClim_2.1_MIROC6_ssp370_5m",TRUE,"WorldClim_2.1_MIROC6_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Sep","min T Sep","september","degrees Celsius","*degree*C*", +"temperature_min_10","temperature_min_10","WorldClim_2.1_MIROC6_ssp370_5m",TRUE,"WorldClim_2.1_MIROC6_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Oct","min T Oct","october","degrees Celsius","*degree*C*", +"temperature_min_11","temperature_min_11","WorldClim_2.1_MIROC6_ssp370_5m",TRUE,"WorldClim_2.1_MIROC6_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Nov","min T Nov","november","degrees Celsius","*degree*C*", +"temperature_min_12","temperature_min_12","WorldClim_2.1_MIROC6_ssp370_5m",TRUE,"WorldClim_2.1_MIROC6_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Dec","min T Dec","december","degrees Celsius","*degree*C*", +"temperature_max_01","temperature_max_01","WorldClim_2.1_MIROC6_ssp370_5m",TRUE,"WorldClim_2.1_MIROC6_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jan","max T Jan","january","degrees Celsius","*degree*C*", +"temperature_max_02","temperature_max_02","WorldClim_2.1_MIROC6_ssp370_5m",TRUE,"WorldClim_2.1_MIROC6_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Feb","max T Feb","february","degrees Celsius","*degree*C*", +"temperature_max_03","temperature_max_03","WorldClim_2.1_MIROC6_ssp370_5m",TRUE,"WorldClim_2.1_MIROC6_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Mar","max T Mar","march","degrees Celsius","*degree*C*", +"temperature_max_04","temperature_max_04","WorldClim_2.1_MIROC6_ssp370_5m",TRUE,"WorldClim_2.1_MIROC6_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Apr","max T Apr","april","degrees Celsius","*degree*C*", +"temperature_max_05","temperature_max_05","WorldClim_2.1_MIROC6_ssp370_5m",TRUE,"WorldClim_2.1_MIROC6_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature May","max T May","may","degrees Celsius","*degree*C*", +"temperature_max_06","temperature_max_06","WorldClim_2.1_MIROC6_ssp370_5m",TRUE,"WorldClim_2.1_MIROC6_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jun","max T Jun","june","degrees Celsius","*degree*C*", +"temperature_max_07","temperature_max_07","WorldClim_2.1_MIROC6_ssp370_5m",TRUE,"WorldClim_2.1_MIROC6_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jul","max T Jul","july","degrees Celsius","*degree*C*", +"temperature_max_08","temperature_max_08","WorldClim_2.1_MIROC6_ssp370_5m",TRUE,"WorldClim_2.1_MIROC6_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Aug","max T Aug","august","degrees Celsius","*degree*C*", +"temperature_max_09","temperature_max_09","WorldClim_2.1_MIROC6_ssp370_5m",TRUE,"WorldClim_2.1_MIROC6_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Sep","max T Sep","september","degrees Celsius","*degree*C*", +"temperature_max_10","temperature_max_10","WorldClim_2.1_MIROC6_ssp370_5m",TRUE,"WorldClim_2.1_MIROC6_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Oct","max T Oct","october","degrees Celsius","*degree*C*", +"temperature_max_11","temperature_max_11","WorldClim_2.1_MIROC6_ssp370_5m",TRUE,"WorldClim_2.1_MIROC6_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Nov","max T Nov","november","degrees Celsius","*degree*C*", +"temperature_max_12","temperature_max_12","WorldClim_2.1_MIROC6_ssp370_5m",TRUE,"WorldClim_2.1_MIROC6_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Dec","max T Dec","december","degrees Celsius","*degree*C*", +"bio01","bio01","WorldClim_2.1_MIROC6_ssp585_10m",FALSE,"WorldClim_2.1_MIROC6_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual mean temperature","ann. mean T","year","degrees Celsius","*degree*C*", +"bio02","bio02","WorldClim_2.1_MIROC6_ssp585_10m",FALSE,"WorldClim_2.1_MIROC6_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean diurnal range","diurn. range","year","degrees Celsius","*degree*C*", +"bio03","bio03","WorldClim_2.1_MIROC6_ssp585_10m",FALSE,"WorldClim_2.1_MIROC6_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","isothermality","isothermality","year","","", +"bio04","bio04","WorldClim_2.1_MIROC6_ssp585_10m",FALSE,"WorldClim_2.1_MIROC6_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature seasonality","T season.","year","degrees Celsius","*degree*C*", +"bio05","bio05","WorldClim_2.1_MIROC6_ssp585_10m",FALSE,"WorldClim_2.1_MIROC6_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature of warmest month","max. T of warmest mo.","year","degrees Celsius","*degree*C*", +"bio06","bio06","WorldClim_2.1_MIROC6_ssp585_10m",FALSE,"WorldClim_2.1_MIROC6_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature of coldest month","min. T of coldest mo.","year","degrees Celsius","*degree*C*", +"bio07","bio07","WorldClim_2.1_MIROC6_ssp585_10m",FALSE,"WorldClim_2.1_MIROC6_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature annual range (bio05-bio06)","T ann. Range","year","degrees Celsius","*degree*C*", +"bio08","bio08","WorldClim_2.1_MIROC6_ssp585_10m",FALSE,"WorldClim_2.1_MIROC6_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of wettest quarter","mean T of wettest qtr","year","degrees Celsius","*degree*C*", +"bio09","bio09","WorldClim_2.1_MIROC6_ssp585_10m",FALSE,"WorldClim_2.1_MIROC6_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of driest quarter","mean T of driest qtr","year","degrees Celsius","*degree*C*", +"bio10","bio10","WorldClim_2.1_MIROC6_ssp585_10m",FALSE,"WorldClim_2.1_MIROC6_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of warmest quarter","mean T of warmest qtr","year","degrees Celsius","*degree*C*", +"bio11","bio11","WorldClim_2.1_MIROC6_ssp585_10m",FALSE,"WorldClim_2.1_MIROC6_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of coldest quarter","mean T of coldest qtr","year","degrees Celsius","*degree*C*", +"bio12","bio12","WorldClim_2.1_MIROC6_ssp585_10m",FALSE,"WorldClim_2.1_MIROC6_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual precipitation","ann. P","year","mm per year","*mm~yr^-1*", +"bio13","bio13","WorldClim_2.1_MIROC6_ssp585_10m",FALSE,"WorldClim_2.1_MIROC6_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest month","P of wettest mo.","year","mm per month","*mm~mo^-1*", +"bio14","bio14","WorldClim_2.1_MIROC6_ssp585_10m",FALSE,"WorldClim_2.1_MIROC6_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest month","P of driest mo.","year","mm per month","*mm~mo^-1*", +"bio15","bio15","WorldClim_2.1_MIROC6_ssp585_10m",FALSE,"WorldClim_2.1_MIROC6_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation seasonality (coeff var)","P season.","year","","", +"bio16","bio16","WorldClim_2.1_MIROC6_ssp585_10m",FALSE,"WorldClim_2.1_MIROC6_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest quarter","P of wettest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio17","bio17","WorldClim_2.1_MIROC6_ssp585_10m",FALSE,"WorldClim_2.1_MIROC6_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest quarter","P of driest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio18","bio18","WorldClim_2.1_MIROC6_ssp585_10m",FALSE,"WorldClim_2.1_MIROC6_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of warmest quarter","P of warmest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio19","bio19","WorldClim_2.1_MIROC6_ssp585_10m",FALSE,"WorldClim_2.1_MIROC6_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of coldest quarter","P of coldest qtr","year","mm per quarter","*mm~qtr^-1*", +"precipitation_01","precipitation_01","WorldClim_2.1_MIROC6_ssp585_10m",TRUE,"WorldClim_2.1_MIROC6_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jan","P Jan","january","mm per month","*mm~mo^-1*", +"precipitation_02","precipitation_02","WorldClim_2.1_MIROC6_ssp585_10m",TRUE,"WorldClim_2.1_MIROC6_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Feb","P Feb","february","mm per month","*mm~mo^-1*", +"precipitation_03","precipitation_03","WorldClim_2.1_MIROC6_ssp585_10m",TRUE,"WorldClim_2.1_MIROC6_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Mar","P Mar","march","mm per month","*mm~mo^-1*", +"precipitation_04","precipitation_04","WorldClim_2.1_MIROC6_ssp585_10m",TRUE,"WorldClim_2.1_MIROC6_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Apr","P Apr","april","mm per month","*mm~mo^-1*", +"precipitation_05","precipitation_05","WorldClim_2.1_MIROC6_ssp585_10m",TRUE,"WorldClim_2.1_MIROC6_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation May","P May","may","mm per month","*mm~mo^-1*", +"precipitation_06","precipitation_06","WorldClim_2.1_MIROC6_ssp585_10m",TRUE,"WorldClim_2.1_MIROC6_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jun","P Jun","june","mm per month","*mm~mo^-1*", +"precipitation_07","precipitation_07","WorldClim_2.1_MIROC6_ssp585_10m",TRUE,"WorldClim_2.1_MIROC6_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jul","P Jul","july","mm per month","*mm~mo^-1*", +"precipitation_08","precipitation_08","WorldClim_2.1_MIROC6_ssp585_10m",TRUE,"WorldClim_2.1_MIROC6_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Aug","P Aug","august","mm per month","*mm~mo^-1*", +"precipitation_09","precipitation_09","WorldClim_2.1_MIROC6_ssp585_10m",TRUE,"WorldClim_2.1_MIROC6_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Sep","P Sep","september","mm per month","*mm~mo^-1*", +"precipitation_10","precipitation_10","WorldClim_2.1_MIROC6_ssp585_10m",TRUE,"WorldClim_2.1_MIROC6_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Oct","P Oct","october","mm per month","*mm~mo^-1*", +"precipitation_11","precipitation_11","WorldClim_2.1_MIROC6_ssp585_10m",TRUE,"WorldClim_2.1_MIROC6_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Nov","P Nov","november","mm per month","*mm~mo^-1*", +"precipitation_12","precipitation_12","WorldClim_2.1_MIROC6_ssp585_10m",TRUE,"WorldClim_2.1_MIROC6_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Dec","P Dec","december","mm per month","*mm~mo^-1*", +"temperature_min_01","temperature_min_01","WorldClim_2.1_MIROC6_ssp585_10m",TRUE,"WorldClim_2.1_MIROC6_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jan","min T Jan","january","degrees Celsius","*degree*C*", +"temperature_min_02","temperature_min_02","WorldClim_2.1_MIROC6_ssp585_10m",TRUE,"WorldClim_2.1_MIROC6_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Feb","min T Feb","february","degrees Celsius","*degree*C*", +"temperature_min_03","temperature_min_03","WorldClim_2.1_MIROC6_ssp585_10m",TRUE,"WorldClim_2.1_MIROC6_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Mar","min T Mar","march","degrees Celsius","*degree*C*", +"temperature_min_04","temperature_min_04","WorldClim_2.1_MIROC6_ssp585_10m",TRUE,"WorldClim_2.1_MIROC6_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Apr","min T Apr","april","degrees Celsius","*degree*C*", +"temperature_min_05","temperature_min_05","WorldClim_2.1_MIROC6_ssp585_10m",TRUE,"WorldClim_2.1_MIROC6_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature May","min T May","may","degrees Celsius","*degree*C*", +"temperature_min_06","temperature_min_06","WorldClim_2.1_MIROC6_ssp585_10m",TRUE,"WorldClim_2.1_MIROC6_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jun","min T Jun","june","degrees Celsius","*degree*C*", +"temperature_min_07","temperature_min_07","WorldClim_2.1_MIROC6_ssp585_10m",TRUE,"WorldClim_2.1_MIROC6_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jul","min T Jul","july","degrees Celsius","*degree*C*", +"temperature_min_08","temperature_min_08","WorldClim_2.1_MIROC6_ssp585_10m",TRUE,"WorldClim_2.1_MIROC6_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Aug","min T Aug","august","degrees Celsius","*degree*C*", +"temperature_min_09","temperature_min_09","WorldClim_2.1_MIROC6_ssp585_10m",TRUE,"WorldClim_2.1_MIROC6_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Sep","min T Sep","september","degrees Celsius","*degree*C*", +"temperature_min_10","temperature_min_10","WorldClim_2.1_MIROC6_ssp585_10m",TRUE,"WorldClim_2.1_MIROC6_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Oct","min T Oct","october","degrees Celsius","*degree*C*", +"temperature_min_11","temperature_min_11","WorldClim_2.1_MIROC6_ssp585_10m",TRUE,"WorldClim_2.1_MIROC6_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Nov","min T Nov","november","degrees Celsius","*degree*C*", +"temperature_min_12","temperature_min_12","WorldClim_2.1_MIROC6_ssp585_10m",TRUE,"WorldClim_2.1_MIROC6_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Dec","min T Dec","december","degrees Celsius","*degree*C*", +"temperature_max_01","temperature_max_01","WorldClim_2.1_MIROC6_ssp585_10m",TRUE,"WorldClim_2.1_MIROC6_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jan","max T Jan","january","degrees Celsius","*degree*C*", +"temperature_max_02","temperature_max_02","WorldClim_2.1_MIROC6_ssp585_10m",TRUE,"WorldClim_2.1_MIROC6_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Feb","max T Feb","february","degrees Celsius","*degree*C*", +"temperature_max_03","temperature_max_03","WorldClim_2.1_MIROC6_ssp585_10m",TRUE,"WorldClim_2.1_MIROC6_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Mar","max T Mar","march","degrees Celsius","*degree*C*", +"temperature_max_04","temperature_max_04","WorldClim_2.1_MIROC6_ssp585_10m",TRUE,"WorldClim_2.1_MIROC6_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Apr","max T Apr","april","degrees Celsius","*degree*C*", +"temperature_max_05","temperature_max_05","WorldClim_2.1_MIROC6_ssp585_10m",TRUE,"WorldClim_2.1_MIROC6_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature May","max T May","may","degrees Celsius","*degree*C*", +"temperature_max_06","temperature_max_06","WorldClim_2.1_MIROC6_ssp585_10m",TRUE,"WorldClim_2.1_MIROC6_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jun","max T Jun","june","degrees Celsius","*degree*C*", +"temperature_max_07","temperature_max_07","WorldClim_2.1_MIROC6_ssp585_10m",TRUE,"WorldClim_2.1_MIROC6_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jul","max T Jul","july","degrees Celsius","*degree*C*", +"temperature_max_08","temperature_max_08","WorldClim_2.1_MIROC6_ssp585_10m",TRUE,"WorldClim_2.1_MIROC6_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Aug","max T Aug","august","degrees Celsius","*degree*C*", +"temperature_max_09","temperature_max_09","WorldClim_2.1_MIROC6_ssp585_10m",TRUE,"WorldClim_2.1_MIROC6_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Sep","max T Sep","september","degrees Celsius","*degree*C*", +"temperature_max_10","temperature_max_10","WorldClim_2.1_MIROC6_ssp585_10m",TRUE,"WorldClim_2.1_MIROC6_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Oct","max T Oct","october","degrees Celsius","*degree*C*", +"temperature_max_11","temperature_max_11","WorldClim_2.1_MIROC6_ssp585_10m",TRUE,"WorldClim_2.1_MIROC6_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Nov","max T Nov","november","degrees Celsius","*degree*C*", +"temperature_max_12","temperature_max_12","WorldClim_2.1_MIROC6_ssp585_10m",TRUE,"WorldClim_2.1_MIROC6_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Dec","max T Dec","december","degrees Celsius","*degree*C*", +"bio01","bio01","WorldClim_2.1_MIROC6_ssp585_5m",FALSE,"WorldClim_2.1_MIROC6_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual mean temperature","ann. mean T","year","degrees Celsius","*degree*C*", +"bio02","bio02","WorldClim_2.1_MIROC6_ssp585_5m",FALSE,"WorldClim_2.1_MIROC6_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean diurnal range","diurn. range","year","degrees Celsius","*degree*C*", +"bio03","bio03","WorldClim_2.1_MIROC6_ssp585_5m",FALSE,"WorldClim_2.1_MIROC6_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","isothermality","isothermality","year","","", +"bio04","bio04","WorldClim_2.1_MIROC6_ssp585_5m",FALSE,"WorldClim_2.1_MIROC6_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature seasonality","T season.","year","degrees Celsius","*degree*C*", +"bio05","bio05","WorldClim_2.1_MIROC6_ssp585_5m",FALSE,"WorldClim_2.1_MIROC6_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature of warmest month","max. T of warmest mo.","year","degrees Celsius","*degree*C*", +"bio06","bio06","WorldClim_2.1_MIROC6_ssp585_5m",FALSE,"WorldClim_2.1_MIROC6_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature of coldest month","min. T of coldest mo.","year","degrees Celsius","*degree*C*", +"bio07","bio07","WorldClim_2.1_MIROC6_ssp585_5m",FALSE,"WorldClim_2.1_MIROC6_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature annual range (bio05-bio06)","T ann. Range","year","degrees Celsius","*degree*C*", +"bio08","bio08","WorldClim_2.1_MIROC6_ssp585_5m",FALSE,"WorldClim_2.1_MIROC6_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of wettest quarter","mean T of wettest qtr","year","degrees Celsius","*degree*C*", +"bio09","bio09","WorldClim_2.1_MIROC6_ssp585_5m",FALSE,"WorldClim_2.1_MIROC6_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of driest quarter","mean T of driest qtr","year","degrees Celsius","*degree*C*", +"bio10","bio10","WorldClim_2.1_MIROC6_ssp585_5m",FALSE,"WorldClim_2.1_MIROC6_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of warmest quarter","mean T of warmest qtr","year","degrees Celsius","*degree*C*", +"bio11","bio11","WorldClim_2.1_MIROC6_ssp585_5m",FALSE,"WorldClim_2.1_MIROC6_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of coldest quarter","mean T of coldest qtr","year","degrees Celsius","*degree*C*", +"bio12","bio12","WorldClim_2.1_MIROC6_ssp585_5m",FALSE,"WorldClim_2.1_MIROC6_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual precipitation","ann. P","year","mm per year","*mm~yr^-1*", +"bio13","bio13","WorldClim_2.1_MIROC6_ssp585_5m",FALSE,"WorldClim_2.1_MIROC6_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest month","P of wettest mo.","year","mm per month","*mm~mo^-1*", +"bio14","bio14","WorldClim_2.1_MIROC6_ssp585_5m",FALSE,"WorldClim_2.1_MIROC6_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest month","P of driest mo.","year","mm per month","*mm~mo^-1*", +"bio15","bio15","WorldClim_2.1_MIROC6_ssp585_5m",FALSE,"WorldClim_2.1_MIROC6_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation seasonality (coeff var)","P season.","year","","", +"bio16","bio16","WorldClim_2.1_MIROC6_ssp585_5m",FALSE,"WorldClim_2.1_MIROC6_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest quarter","P of wettest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio17","bio17","WorldClim_2.1_MIROC6_ssp585_5m",FALSE,"WorldClim_2.1_MIROC6_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest quarter","P of driest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio18","bio18","WorldClim_2.1_MIROC6_ssp585_5m",FALSE,"WorldClim_2.1_MIROC6_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of warmest quarter","P of warmest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio19","bio19","WorldClim_2.1_MIROC6_ssp585_5m",FALSE,"WorldClim_2.1_MIROC6_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of coldest quarter","P of coldest qtr","year","mm per quarter","*mm~qtr^-1*", +"precipitation_01","precipitation_01","WorldClim_2.1_MIROC6_ssp585_5m",TRUE,"WorldClim_2.1_MIROC6_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jan","P Jan","january","mm per month","*mm~mo^-1*", +"precipitation_02","precipitation_02","WorldClim_2.1_MIROC6_ssp585_5m",TRUE,"WorldClim_2.1_MIROC6_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Feb","P Feb","february","mm per month","*mm~mo^-1*", +"precipitation_03","precipitation_03","WorldClim_2.1_MIROC6_ssp585_5m",TRUE,"WorldClim_2.1_MIROC6_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Mar","P Mar","march","mm per month","*mm~mo^-1*", +"precipitation_04","precipitation_04","WorldClim_2.1_MIROC6_ssp585_5m",TRUE,"WorldClim_2.1_MIROC6_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Apr","P Apr","april","mm per month","*mm~mo^-1*", +"precipitation_05","precipitation_05","WorldClim_2.1_MIROC6_ssp585_5m",TRUE,"WorldClim_2.1_MIROC6_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation May","P May","may","mm per month","*mm~mo^-1*", +"precipitation_06","precipitation_06","WorldClim_2.1_MIROC6_ssp585_5m",TRUE,"WorldClim_2.1_MIROC6_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jun","P Jun","june","mm per month","*mm~mo^-1*", +"precipitation_07","precipitation_07","WorldClim_2.1_MIROC6_ssp585_5m",TRUE,"WorldClim_2.1_MIROC6_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jul","P Jul","july","mm per month","*mm~mo^-1*", +"precipitation_08","precipitation_08","WorldClim_2.1_MIROC6_ssp585_5m",TRUE,"WorldClim_2.1_MIROC6_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Aug","P Aug","august","mm per month","*mm~mo^-1*", +"precipitation_09","precipitation_09","WorldClim_2.1_MIROC6_ssp585_5m",TRUE,"WorldClim_2.1_MIROC6_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Sep","P Sep","september","mm per month","*mm~mo^-1*", +"precipitation_10","precipitation_10","WorldClim_2.1_MIROC6_ssp585_5m",TRUE,"WorldClim_2.1_MIROC6_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Oct","P Oct","october","mm per month","*mm~mo^-1*", +"precipitation_11","precipitation_11","WorldClim_2.1_MIROC6_ssp585_5m",TRUE,"WorldClim_2.1_MIROC6_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Nov","P Nov","november","mm per month","*mm~mo^-1*", +"precipitation_12","precipitation_12","WorldClim_2.1_MIROC6_ssp585_5m",TRUE,"WorldClim_2.1_MIROC6_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Dec","P Dec","december","mm per month","*mm~mo^-1*", +"temperature_min_01","temperature_min_01","WorldClim_2.1_MIROC6_ssp585_5m",TRUE,"WorldClim_2.1_MIROC6_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jan","min T Jan","january","degrees Celsius","*degree*C*", +"temperature_min_02","temperature_min_02","WorldClim_2.1_MIROC6_ssp585_5m",TRUE,"WorldClim_2.1_MIROC6_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Feb","min T Feb","february","degrees Celsius","*degree*C*", +"temperature_min_03","temperature_min_03","WorldClim_2.1_MIROC6_ssp585_5m",TRUE,"WorldClim_2.1_MIROC6_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Mar","min T Mar","march","degrees Celsius","*degree*C*", +"temperature_min_04","temperature_min_04","WorldClim_2.1_MIROC6_ssp585_5m",TRUE,"WorldClim_2.1_MIROC6_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Apr","min T Apr","april","degrees Celsius","*degree*C*", +"temperature_min_05","temperature_min_05","WorldClim_2.1_MIROC6_ssp585_5m",TRUE,"WorldClim_2.1_MIROC6_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature May","min T May","may","degrees Celsius","*degree*C*", +"temperature_min_06","temperature_min_06","WorldClim_2.1_MIROC6_ssp585_5m",TRUE,"WorldClim_2.1_MIROC6_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jun","min T Jun","june","degrees Celsius","*degree*C*", +"temperature_min_07","temperature_min_07","WorldClim_2.1_MIROC6_ssp585_5m",TRUE,"WorldClim_2.1_MIROC6_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jul","min T Jul","july","degrees Celsius","*degree*C*", +"temperature_min_08","temperature_min_08","WorldClim_2.1_MIROC6_ssp585_5m",TRUE,"WorldClim_2.1_MIROC6_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Aug","min T Aug","august","degrees Celsius","*degree*C*", +"temperature_min_09","temperature_min_09","WorldClim_2.1_MIROC6_ssp585_5m",TRUE,"WorldClim_2.1_MIROC6_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Sep","min T Sep","september","degrees Celsius","*degree*C*", +"temperature_min_10","temperature_min_10","WorldClim_2.1_MIROC6_ssp585_5m",TRUE,"WorldClim_2.1_MIROC6_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Oct","min T Oct","october","degrees Celsius","*degree*C*", +"temperature_min_11","temperature_min_11","WorldClim_2.1_MIROC6_ssp585_5m",TRUE,"WorldClim_2.1_MIROC6_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Nov","min T Nov","november","degrees Celsius","*degree*C*", +"temperature_min_12","temperature_min_12","WorldClim_2.1_MIROC6_ssp585_5m",TRUE,"WorldClim_2.1_MIROC6_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Dec","min T Dec","december","degrees Celsius","*degree*C*", +"temperature_max_01","temperature_max_01","WorldClim_2.1_MIROC6_ssp585_5m",TRUE,"WorldClim_2.1_MIROC6_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jan","max T Jan","january","degrees Celsius","*degree*C*", +"temperature_max_02","temperature_max_02","WorldClim_2.1_MIROC6_ssp585_5m",TRUE,"WorldClim_2.1_MIROC6_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Feb","max T Feb","february","degrees Celsius","*degree*C*", +"temperature_max_03","temperature_max_03","WorldClim_2.1_MIROC6_ssp585_5m",TRUE,"WorldClim_2.1_MIROC6_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Mar","max T Mar","march","degrees Celsius","*degree*C*", +"temperature_max_04","temperature_max_04","WorldClim_2.1_MIROC6_ssp585_5m",TRUE,"WorldClim_2.1_MIROC6_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Apr","max T Apr","april","degrees Celsius","*degree*C*", +"temperature_max_05","temperature_max_05","WorldClim_2.1_MIROC6_ssp585_5m",TRUE,"WorldClim_2.1_MIROC6_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature May","max T May","may","degrees Celsius","*degree*C*", +"temperature_max_06","temperature_max_06","WorldClim_2.1_MIROC6_ssp585_5m",TRUE,"WorldClim_2.1_MIROC6_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jun","max T Jun","june","degrees Celsius","*degree*C*", +"temperature_max_07","temperature_max_07","WorldClim_2.1_MIROC6_ssp585_5m",TRUE,"WorldClim_2.1_MIROC6_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jul","max T Jul","july","degrees Celsius","*degree*C*", +"temperature_max_08","temperature_max_08","WorldClim_2.1_MIROC6_ssp585_5m",TRUE,"WorldClim_2.1_MIROC6_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Aug","max T Aug","august","degrees Celsius","*degree*C*", +"temperature_max_09","temperature_max_09","WorldClim_2.1_MIROC6_ssp585_5m",TRUE,"WorldClim_2.1_MIROC6_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Sep","max T Sep","september","degrees Celsius","*degree*C*", +"temperature_max_10","temperature_max_10","WorldClim_2.1_MIROC6_ssp585_5m",TRUE,"WorldClim_2.1_MIROC6_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Oct","max T Oct","october","degrees Celsius","*degree*C*", +"temperature_max_11","temperature_max_11","WorldClim_2.1_MIROC6_ssp585_5m",TRUE,"WorldClim_2.1_MIROC6_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Nov","max T Nov","november","degrees Celsius","*degree*C*", +"temperature_max_12","temperature_max_12","WorldClim_2.1_MIROC6_ssp585_5m",TRUE,"WorldClim_2.1_MIROC6_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Dec","max T Dec","december","degrees Celsius","*degree*C*", +"bio01","bio01","WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual mean temperature","ann. mean T","year","degrees Celsius","*degree*C*", +"bio02","bio02","WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean diurnal range","diurn. range","year","degrees Celsius","*degree*C*", +"bio03","bio03","WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","isothermality","isothermality","year","","", +"bio04","bio04","WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature seasonality","T season.","year","degrees Celsius","*degree*C*", +"bio05","bio05","WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature of warmest month","max. T of warmest mo.","year","degrees Celsius","*degree*C*", +"bio06","bio06","WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature of coldest month","min. T of coldest mo.","year","degrees Celsius","*degree*C*", +"bio07","bio07","WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature annual range (bio05-bio06)","T ann. Range","year","degrees Celsius","*degree*C*", +"bio08","bio08","WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of wettest quarter","mean T of wettest qtr","year","degrees Celsius","*degree*C*", +"bio09","bio09","WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of driest quarter","mean T of driest qtr","year","degrees Celsius","*degree*C*", +"bio10","bio10","WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of warmest quarter","mean T of warmest qtr","year","degrees Celsius","*degree*C*", +"bio11","bio11","WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of coldest quarter","mean T of coldest qtr","year","degrees Celsius","*degree*C*", +"bio12","bio12","WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual precipitation","ann. P","year","mm per year","*mm~yr^-1*", +"bio13","bio13","WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest month","P of wettest mo.","year","mm per month","*mm~mo^-1*", +"bio14","bio14","WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest month","P of driest mo.","year","mm per month","*mm~mo^-1*", +"bio15","bio15","WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation seasonality (coeff var)","P season.","year","","", +"bio16","bio16","WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest quarter","P of wettest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio17","bio17","WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest quarter","P of driest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio18","bio18","WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of warmest quarter","P of warmest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio19","bio19","WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of coldest quarter","P of coldest qtr","year","mm per quarter","*mm~qtr^-1*", +"precipitation_01","precipitation_01","WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jan","P Jan","january","mm per month","*mm~mo^-1*", +"precipitation_02","precipitation_02","WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Feb","P Feb","february","mm per month","*mm~mo^-1*", +"precipitation_03","precipitation_03","WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Mar","P Mar","march","mm per month","*mm~mo^-1*", +"precipitation_04","precipitation_04","WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Apr","P Apr","april","mm per month","*mm~mo^-1*", +"precipitation_05","precipitation_05","WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation May","P May","may","mm per month","*mm~mo^-1*", +"precipitation_06","precipitation_06","WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jun","P Jun","june","mm per month","*mm~mo^-1*", +"precipitation_07","precipitation_07","WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jul","P Jul","july","mm per month","*mm~mo^-1*", +"precipitation_08","precipitation_08","WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Aug","P Aug","august","mm per month","*mm~mo^-1*", +"precipitation_09","precipitation_09","WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Sep","P Sep","september","mm per month","*mm~mo^-1*", +"precipitation_10","precipitation_10","WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Oct","P Oct","october","mm per month","*mm~mo^-1*", +"precipitation_11","precipitation_11","WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Nov","P Nov","november","mm per month","*mm~mo^-1*", +"precipitation_12","precipitation_12","WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Dec","P Dec","december","mm per month","*mm~mo^-1*", +"temperature_min_01","temperature_min_01","WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jan","min T Jan","january","degrees Celsius","*degree*C*", +"temperature_min_02","temperature_min_02","WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Feb","min T Feb","february","degrees Celsius","*degree*C*", +"temperature_min_03","temperature_min_03","WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Mar","min T Mar","march","degrees Celsius","*degree*C*", +"temperature_min_04","temperature_min_04","WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Apr","min T Apr","april","degrees Celsius","*degree*C*", +"temperature_min_05","temperature_min_05","WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature May","min T May","may","degrees Celsius","*degree*C*", +"temperature_min_06","temperature_min_06","WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jun","min T Jun","june","degrees Celsius","*degree*C*", +"temperature_min_07","temperature_min_07","WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jul","min T Jul","july","degrees Celsius","*degree*C*", +"temperature_min_08","temperature_min_08","WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Aug","min T Aug","august","degrees Celsius","*degree*C*", +"temperature_min_09","temperature_min_09","WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Sep","min T Sep","september","degrees Celsius","*degree*C*", +"temperature_min_10","temperature_min_10","WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Oct","min T Oct","october","degrees Celsius","*degree*C*", +"temperature_min_11","temperature_min_11","WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Nov","min T Nov","november","degrees Celsius","*degree*C*", +"temperature_min_12","temperature_min_12","WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Dec","min T Dec","december","degrees Celsius","*degree*C*", +"temperature_max_01","temperature_max_01","WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jan","max T Jan","january","degrees Celsius","*degree*C*", +"temperature_max_02","temperature_max_02","WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Feb","max T Feb","february","degrees Celsius","*degree*C*", +"temperature_max_03","temperature_max_03","WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Mar","max T Mar","march","degrees Celsius","*degree*C*", +"temperature_max_04","temperature_max_04","WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Apr","max T Apr","april","degrees Celsius","*degree*C*", +"temperature_max_05","temperature_max_05","WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature May","max T May","may","degrees Celsius","*degree*C*", +"temperature_max_06","temperature_max_06","WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jun","max T Jun","june","degrees Celsius","*degree*C*", +"temperature_max_07","temperature_max_07","WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jul","max T Jul","july","degrees Celsius","*degree*C*", +"temperature_max_08","temperature_max_08","WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Aug","max T Aug","august","degrees Celsius","*degree*C*", +"temperature_max_09","temperature_max_09","WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Sep","max T Sep","september","degrees Celsius","*degree*C*", +"temperature_max_10","temperature_max_10","WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Oct","max T Oct","october","degrees Celsius","*degree*C*", +"temperature_max_11","temperature_max_11","WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Nov","max T Nov","november","degrees Celsius","*degree*C*", +"temperature_max_12","temperature_max_12","WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Dec","max T Dec","december","degrees Celsius","*degree*C*", +"bio01","bio01","WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual mean temperature","ann. mean T","year","degrees Celsius","*degree*C*", +"bio02","bio02","WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean diurnal range","diurn. range","year","degrees Celsius","*degree*C*", +"bio03","bio03","WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","isothermality","isothermality","year","","", +"bio04","bio04","WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature seasonality","T season.","year","degrees Celsius","*degree*C*", +"bio05","bio05","WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature of warmest month","max. T of warmest mo.","year","degrees Celsius","*degree*C*", +"bio06","bio06","WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature of coldest month","min. T of coldest mo.","year","degrees Celsius","*degree*C*", +"bio07","bio07","WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature annual range (bio05-bio06)","T ann. Range","year","degrees Celsius","*degree*C*", +"bio08","bio08","WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of wettest quarter","mean T of wettest qtr","year","degrees Celsius","*degree*C*", +"bio09","bio09","WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of driest quarter","mean T of driest qtr","year","degrees Celsius","*degree*C*", +"bio10","bio10","WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of warmest quarter","mean T of warmest qtr","year","degrees Celsius","*degree*C*", +"bio11","bio11","WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of coldest quarter","mean T of coldest qtr","year","degrees Celsius","*degree*C*", +"bio12","bio12","WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual precipitation","ann. P","year","mm per year","*mm~yr^-1*", +"bio13","bio13","WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest month","P of wettest mo.","year","mm per month","*mm~mo^-1*", +"bio14","bio14","WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest month","P of driest mo.","year","mm per month","*mm~mo^-1*", +"bio15","bio15","WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation seasonality (coeff var)","P season.","year","","", +"bio16","bio16","WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest quarter","P of wettest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio17","bio17","WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest quarter","P of driest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio18","bio18","WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of warmest quarter","P of warmest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio19","bio19","WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of coldest quarter","P of coldest qtr","year","mm per quarter","*mm~qtr^-1*", +"precipitation_01","precipitation_01","WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jan","P Jan","january","mm per month","*mm~mo^-1*", +"precipitation_02","precipitation_02","WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Feb","P Feb","february","mm per month","*mm~mo^-1*", +"precipitation_03","precipitation_03","WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Mar","P Mar","march","mm per month","*mm~mo^-1*", +"precipitation_04","precipitation_04","WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Apr","P Apr","april","mm per month","*mm~mo^-1*", +"precipitation_05","precipitation_05","WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation May","P May","may","mm per month","*mm~mo^-1*", +"precipitation_06","precipitation_06","WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jun","P Jun","june","mm per month","*mm~mo^-1*", +"precipitation_07","precipitation_07","WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jul","P Jul","july","mm per month","*mm~mo^-1*", +"precipitation_08","precipitation_08","WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Aug","P Aug","august","mm per month","*mm~mo^-1*", +"precipitation_09","precipitation_09","WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Sep","P Sep","september","mm per month","*mm~mo^-1*", +"precipitation_10","precipitation_10","WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Oct","P Oct","october","mm per month","*mm~mo^-1*", +"precipitation_11","precipitation_11","WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Nov","P Nov","november","mm per month","*mm~mo^-1*", +"precipitation_12","precipitation_12","WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Dec","P Dec","december","mm per month","*mm~mo^-1*", +"temperature_min_01","temperature_min_01","WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jan","min T Jan","january","degrees Celsius","*degree*C*", +"temperature_min_02","temperature_min_02","WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Feb","min T Feb","february","degrees Celsius","*degree*C*", +"temperature_min_03","temperature_min_03","WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Mar","min T Mar","march","degrees Celsius","*degree*C*", +"temperature_min_04","temperature_min_04","WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Apr","min T Apr","april","degrees Celsius","*degree*C*", +"temperature_min_05","temperature_min_05","WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature May","min T May","may","degrees Celsius","*degree*C*", +"temperature_min_06","temperature_min_06","WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jun","min T Jun","june","degrees Celsius","*degree*C*", +"temperature_min_07","temperature_min_07","WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jul","min T Jul","july","degrees Celsius","*degree*C*", +"temperature_min_08","temperature_min_08","WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Aug","min T Aug","august","degrees Celsius","*degree*C*", +"temperature_min_09","temperature_min_09","WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Sep","min T Sep","september","degrees Celsius","*degree*C*", +"temperature_min_10","temperature_min_10","WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Oct","min T Oct","october","degrees Celsius","*degree*C*", +"temperature_min_11","temperature_min_11","WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Nov","min T Nov","november","degrees Celsius","*degree*C*", +"temperature_min_12","temperature_min_12","WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Dec","min T Dec","december","degrees Celsius","*degree*C*", +"temperature_max_01","temperature_max_01","WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jan","max T Jan","january","degrees Celsius","*degree*C*", +"temperature_max_02","temperature_max_02","WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Feb","max T Feb","february","degrees Celsius","*degree*C*", +"temperature_max_03","temperature_max_03","WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Mar","max T Mar","march","degrees Celsius","*degree*C*", +"temperature_max_04","temperature_max_04","WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Apr","max T Apr","april","degrees Celsius","*degree*C*", +"temperature_max_05","temperature_max_05","WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature May","max T May","may","degrees Celsius","*degree*C*", +"temperature_max_06","temperature_max_06","WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jun","max T Jun","june","degrees Celsius","*degree*C*", +"temperature_max_07","temperature_max_07","WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jul","max T Jul","july","degrees Celsius","*degree*C*", +"temperature_max_08","temperature_max_08","WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Aug","max T Aug","august","degrees Celsius","*degree*C*", +"temperature_max_09","temperature_max_09","WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Sep","max T Sep","september","degrees Celsius","*degree*C*", +"temperature_max_10","temperature_max_10","WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Oct","max T Oct","october","degrees Celsius","*degree*C*", +"temperature_max_11","temperature_max_11","WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Nov","max T Nov","november","degrees Celsius","*degree*C*", +"temperature_max_12","temperature_max_12","WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Dec","max T Dec","december","degrees Celsius","*degree*C*", +"bio01","bio01","WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual mean temperature","ann. mean T","year","degrees Celsius","*degree*C*", +"bio02","bio02","WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean diurnal range","diurn. range","year","degrees Celsius","*degree*C*", +"bio03","bio03","WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","isothermality","isothermality","year","","", +"bio04","bio04","WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature seasonality","T season.","year","degrees Celsius","*degree*C*", +"bio05","bio05","WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature of warmest month","max. T of warmest mo.","year","degrees Celsius","*degree*C*", +"bio06","bio06","WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature of coldest month","min. T of coldest mo.","year","degrees Celsius","*degree*C*", +"bio07","bio07","WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature annual range (bio05-bio06)","T ann. Range","year","degrees Celsius","*degree*C*", +"bio08","bio08","WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of wettest quarter","mean T of wettest qtr","year","degrees Celsius","*degree*C*", +"bio09","bio09","WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of driest quarter","mean T of driest qtr","year","degrees Celsius","*degree*C*", +"bio10","bio10","WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of warmest quarter","mean T of warmest qtr","year","degrees Celsius","*degree*C*", +"bio11","bio11","WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of coldest quarter","mean T of coldest qtr","year","degrees Celsius","*degree*C*", +"bio12","bio12","WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual precipitation","ann. P","year","mm per year","*mm~yr^-1*", +"bio13","bio13","WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest month","P of wettest mo.","year","mm per month","*mm~mo^-1*", +"bio14","bio14","WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest month","P of driest mo.","year","mm per month","*mm~mo^-1*", +"bio15","bio15","WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation seasonality (coeff var)","P season.","year","","", +"bio16","bio16","WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest quarter","P of wettest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio17","bio17","WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest quarter","P of driest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio18","bio18","WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of warmest quarter","P of warmest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio19","bio19","WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of coldest quarter","P of coldest qtr","year","mm per quarter","*mm~qtr^-1*", +"precipitation_01","precipitation_01","WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jan","P Jan","january","mm per month","*mm~mo^-1*", +"precipitation_02","precipitation_02","WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Feb","P Feb","february","mm per month","*mm~mo^-1*", +"precipitation_03","precipitation_03","WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Mar","P Mar","march","mm per month","*mm~mo^-1*", +"precipitation_04","precipitation_04","WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Apr","P Apr","april","mm per month","*mm~mo^-1*", +"precipitation_05","precipitation_05","WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation May","P May","may","mm per month","*mm~mo^-1*", +"precipitation_06","precipitation_06","WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jun","P Jun","june","mm per month","*mm~mo^-1*", +"precipitation_07","precipitation_07","WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jul","P Jul","july","mm per month","*mm~mo^-1*", +"precipitation_08","precipitation_08","WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Aug","P Aug","august","mm per month","*mm~mo^-1*", +"precipitation_09","precipitation_09","WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Sep","P Sep","september","mm per month","*mm~mo^-1*", +"precipitation_10","precipitation_10","WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Oct","P Oct","october","mm per month","*mm~mo^-1*", +"precipitation_11","precipitation_11","WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Nov","P Nov","november","mm per month","*mm~mo^-1*", +"precipitation_12","precipitation_12","WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Dec","P Dec","december","mm per month","*mm~mo^-1*", +"temperature_min_01","temperature_min_01","WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jan","min T Jan","january","degrees Celsius","*degree*C*", +"temperature_min_02","temperature_min_02","WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Feb","min T Feb","february","degrees Celsius","*degree*C*", +"temperature_min_03","temperature_min_03","WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Mar","min T Mar","march","degrees Celsius","*degree*C*", +"temperature_min_04","temperature_min_04","WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Apr","min T Apr","april","degrees Celsius","*degree*C*", +"temperature_min_05","temperature_min_05","WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature May","min T May","may","degrees Celsius","*degree*C*", +"temperature_min_06","temperature_min_06","WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jun","min T Jun","june","degrees Celsius","*degree*C*", +"temperature_min_07","temperature_min_07","WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jul","min T Jul","july","degrees Celsius","*degree*C*", +"temperature_min_08","temperature_min_08","WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Aug","min T Aug","august","degrees Celsius","*degree*C*", +"temperature_min_09","temperature_min_09","WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Sep","min T Sep","september","degrees Celsius","*degree*C*", +"temperature_min_10","temperature_min_10","WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Oct","min T Oct","october","degrees Celsius","*degree*C*", +"temperature_min_11","temperature_min_11","WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Nov","min T Nov","november","degrees Celsius","*degree*C*", +"temperature_min_12","temperature_min_12","WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Dec","min T Dec","december","degrees Celsius","*degree*C*", +"temperature_max_01","temperature_max_01","WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jan","max T Jan","january","degrees Celsius","*degree*C*", +"temperature_max_02","temperature_max_02","WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Feb","max T Feb","february","degrees Celsius","*degree*C*", +"temperature_max_03","temperature_max_03","WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Mar","max T Mar","march","degrees Celsius","*degree*C*", +"temperature_max_04","temperature_max_04","WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Apr","max T Apr","april","degrees Celsius","*degree*C*", +"temperature_max_05","temperature_max_05","WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature May","max T May","may","degrees Celsius","*degree*C*", +"temperature_max_06","temperature_max_06","WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jun","max T Jun","june","degrees Celsius","*degree*C*", +"temperature_max_07","temperature_max_07","WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jul","max T Jul","july","degrees Celsius","*degree*C*", +"temperature_max_08","temperature_max_08","WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Aug","max T Aug","august","degrees Celsius","*degree*C*", +"temperature_max_09","temperature_max_09","WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Sep","max T Sep","september","degrees Celsius","*degree*C*", +"temperature_max_10","temperature_max_10","WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Oct","max T Oct","october","degrees Celsius","*degree*C*", +"temperature_max_11","temperature_max_11","WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Nov","max T Nov","november","degrees Celsius","*degree*C*", +"temperature_max_12","temperature_max_12","WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Dec","max T Dec","december","degrees Celsius","*degree*C*", +"bio01","bio01","WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual mean temperature","ann. mean T","year","degrees Celsius","*degree*C*", +"bio02","bio02","WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean diurnal range","diurn. range","year","degrees Celsius","*degree*C*", +"bio03","bio03","WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","isothermality","isothermality","year","","", +"bio04","bio04","WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature seasonality","T season.","year","degrees Celsius","*degree*C*", +"bio05","bio05","WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature of warmest month","max. T of warmest mo.","year","degrees Celsius","*degree*C*", +"bio06","bio06","WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature of coldest month","min. T of coldest mo.","year","degrees Celsius","*degree*C*", +"bio07","bio07","WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature annual range (bio05-bio06)","T ann. Range","year","degrees Celsius","*degree*C*", +"bio08","bio08","WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of wettest quarter","mean T of wettest qtr","year","degrees Celsius","*degree*C*", +"bio09","bio09","WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of driest quarter","mean T of driest qtr","year","degrees Celsius","*degree*C*", +"bio10","bio10","WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of warmest quarter","mean T of warmest qtr","year","degrees Celsius","*degree*C*", +"bio11","bio11","WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of coldest quarter","mean T of coldest qtr","year","degrees Celsius","*degree*C*", +"bio12","bio12","WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual precipitation","ann. P","year","mm per year","*mm~yr^-1*", +"bio13","bio13","WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest month","P of wettest mo.","year","mm per month","*mm~mo^-1*", +"bio14","bio14","WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest month","P of driest mo.","year","mm per month","*mm~mo^-1*", +"bio15","bio15","WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation seasonality (coeff var)","P season.","year","","", +"bio16","bio16","WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest quarter","P of wettest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio17","bio17","WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest quarter","P of driest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio18","bio18","WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of warmest quarter","P of warmest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio19","bio19","WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of coldest quarter","P of coldest qtr","year","mm per quarter","*mm~qtr^-1*", +"precipitation_01","precipitation_01","WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jan","P Jan","january","mm per month","*mm~mo^-1*", +"precipitation_02","precipitation_02","WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Feb","P Feb","february","mm per month","*mm~mo^-1*", +"precipitation_03","precipitation_03","WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Mar","P Mar","march","mm per month","*mm~mo^-1*", +"precipitation_04","precipitation_04","WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Apr","P Apr","april","mm per month","*mm~mo^-1*", +"precipitation_05","precipitation_05","WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation May","P May","may","mm per month","*mm~mo^-1*", +"precipitation_06","precipitation_06","WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jun","P Jun","june","mm per month","*mm~mo^-1*", +"precipitation_07","precipitation_07","WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jul","P Jul","july","mm per month","*mm~mo^-1*", +"precipitation_08","precipitation_08","WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Aug","P Aug","august","mm per month","*mm~mo^-1*", +"precipitation_09","precipitation_09","WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Sep","P Sep","september","mm per month","*mm~mo^-1*", +"precipitation_10","precipitation_10","WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Oct","P Oct","october","mm per month","*mm~mo^-1*", +"precipitation_11","precipitation_11","WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Nov","P Nov","november","mm per month","*mm~mo^-1*", +"precipitation_12","precipitation_12","WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Dec","P Dec","december","mm per month","*mm~mo^-1*", +"temperature_min_01","temperature_min_01","WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jan","min T Jan","january","degrees Celsius","*degree*C*", +"temperature_min_02","temperature_min_02","WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Feb","min T Feb","february","degrees Celsius","*degree*C*", +"temperature_min_03","temperature_min_03","WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Mar","min T Mar","march","degrees Celsius","*degree*C*", +"temperature_min_04","temperature_min_04","WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Apr","min T Apr","april","degrees Celsius","*degree*C*", +"temperature_min_05","temperature_min_05","WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature May","min T May","may","degrees Celsius","*degree*C*", +"temperature_min_06","temperature_min_06","WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jun","min T Jun","june","degrees Celsius","*degree*C*", +"temperature_min_07","temperature_min_07","WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jul","min T Jul","july","degrees Celsius","*degree*C*", +"temperature_min_08","temperature_min_08","WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Aug","min T Aug","august","degrees Celsius","*degree*C*", +"temperature_min_09","temperature_min_09","WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Sep","min T Sep","september","degrees Celsius","*degree*C*", +"temperature_min_10","temperature_min_10","WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Oct","min T Oct","october","degrees Celsius","*degree*C*", +"temperature_min_11","temperature_min_11","WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Nov","min T Nov","november","degrees Celsius","*degree*C*", +"temperature_min_12","temperature_min_12","WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Dec","min T Dec","december","degrees Celsius","*degree*C*", +"temperature_max_01","temperature_max_01","WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jan","max T Jan","january","degrees Celsius","*degree*C*", +"temperature_max_02","temperature_max_02","WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Feb","max T Feb","february","degrees Celsius","*degree*C*", +"temperature_max_03","temperature_max_03","WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Mar","max T Mar","march","degrees Celsius","*degree*C*", +"temperature_max_04","temperature_max_04","WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Apr","max T Apr","april","degrees Celsius","*degree*C*", +"temperature_max_05","temperature_max_05","WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature May","max T May","may","degrees Celsius","*degree*C*", +"temperature_max_06","temperature_max_06","WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jun","max T Jun","june","degrees Celsius","*degree*C*", +"temperature_max_07","temperature_max_07","WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jul","max T Jul","july","degrees Celsius","*degree*C*", +"temperature_max_08","temperature_max_08","WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Aug","max T Aug","august","degrees Celsius","*degree*C*", +"temperature_max_09","temperature_max_09","WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Sep","max T Sep","september","degrees Celsius","*degree*C*", +"temperature_max_10","temperature_max_10","WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Oct","max T Oct","october","degrees Celsius","*degree*C*", +"temperature_max_11","temperature_max_11","WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Nov","max T Nov","november","degrees Celsius","*degree*C*", +"temperature_max_12","temperature_max_12","WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Dec","max T Dec","december","degrees Celsius","*degree*C*", +"bio01","bio01","WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual mean temperature","ann. mean T","year","degrees Celsius","*degree*C*", +"bio02","bio02","WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean diurnal range","diurn. range","year","degrees Celsius","*degree*C*", +"bio03","bio03","WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","isothermality","isothermality","year","","", +"bio04","bio04","WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature seasonality","T season.","year","degrees Celsius","*degree*C*", +"bio05","bio05","WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature of warmest month","max. T of warmest mo.","year","degrees Celsius","*degree*C*", +"bio06","bio06","WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature of coldest month","min. T of coldest mo.","year","degrees Celsius","*degree*C*", +"bio07","bio07","WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature annual range (bio05-bio06)","T ann. Range","year","degrees Celsius","*degree*C*", +"bio08","bio08","WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of wettest quarter","mean T of wettest qtr","year","degrees Celsius","*degree*C*", +"bio09","bio09","WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of driest quarter","mean T of driest qtr","year","degrees Celsius","*degree*C*", +"bio10","bio10","WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of warmest quarter","mean T of warmest qtr","year","degrees Celsius","*degree*C*", +"bio11","bio11","WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of coldest quarter","mean T of coldest qtr","year","degrees Celsius","*degree*C*", +"bio12","bio12","WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual precipitation","ann. P","year","mm per year","*mm~yr^-1*", +"bio13","bio13","WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest month","P of wettest mo.","year","mm per month","*mm~mo^-1*", +"bio14","bio14","WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest month","P of driest mo.","year","mm per month","*mm~mo^-1*", +"bio15","bio15","WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation seasonality (coeff var)","P season.","year","","", +"bio16","bio16","WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest quarter","P of wettest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio17","bio17","WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest quarter","P of driest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio18","bio18","WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of warmest quarter","P of warmest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio19","bio19","WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of coldest quarter","P of coldest qtr","year","mm per quarter","*mm~qtr^-1*", +"precipitation_01","precipitation_01","WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jan","P Jan","january","mm per month","*mm~mo^-1*", +"precipitation_02","precipitation_02","WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Feb","P Feb","february","mm per month","*mm~mo^-1*", +"precipitation_03","precipitation_03","WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Mar","P Mar","march","mm per month","*mm~mo^-1*", +"precipitation_04","precipitation_04","WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Apr","P Apr","april","mm per month","*mm~mo^-1*", +"precipitation_05","precipitation_05","WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation May","P May","may","mm per month","*mm~mo^-1*", +"precipitation_06","precipitation_06","WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jun","P Jun","june","mm per month","*mm~mo^-1*", +"precipitation_07","precipitation_07","WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jul","P Jul","july","mm per month","*mm~mo^-1*", +"precipitation_08","precipitation_08","WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Aug","P Aug","august","mm per month","*mm~mo^-1*", +"precipitation_09","precipitation_09","WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Sep","P Sep","september","mm per month","*mm~mo^-1*", +"precipitation_10","precipitation_10","WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Oct","P Oct","october","mm per month","*mm~mo^-1*", +"precipitation_11","precipitation_11","WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Nov","P Nov","november","mm per month","*mm~mo^-1*", +"precipitation_12","precipitation_12","WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Dec","P Dec","december","mm per month","*mm~mo^-1*", +"temperature_min_01","temperature_min_01","WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jan","min T Jan","january","degrees Celsius","*degree*C*", +"temperature_min_02","temperature_min_02","WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Feb","min T Feb","february","degrees Celsius","*degree*C*", +"temperature_min_03","temperature_min_03","WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Mar","min T Mar","march","degrees Celsius","*degree*C*", +"temperature_min_04","temperature_min_04","WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Apr","min T Apr","april","degrees Celsius","*degree*C*", +"temperature_min_05","temperature_min_05","WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature May","min T May","may","degrees Celsius","*degree*C*", +"temperature_min_06","temperature_min_06","WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jun","min T Jun","june","degrees Celsius","*degree*C*", +"temperature_min_07","temperature_min_07","WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jul","min T Jul","july","degrees Celsius","*degree*C*", +"temperature_min_08","temperature_min_08","WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Aug","min T Aug","august","degrees Celsius","*degree*C*", +"temperature_min_09","temperature_min_09","WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Sep","min T Sep","september","degrees Celsius","*degree*C*", +"temperature_min_10","temperature_min_10","WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Oct","min T Oct","october","degrees Celsius","*degree*C*", +"temperature_min_11","temperature_min_11","WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Nov","min T Nov","november","degrees Celsius","*degree*C*", +"temperature_min_12","temperature_min_12","WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Dec","min T Dec","december","degrees Celsius","*degree*C*", +"temperature_max_01","temperature_max_01","WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jan","max T Jan","january","degrees Celsius","*degree*C*", +"temperature_max_02","temperature_max_02","WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Feb","max T Feb","february","degrees Celsius","*degree*C*", +"temperature_max_03","temperature_max_03","WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Mar","max T Mar","march","degrees Celsius","*degree*C*", +"temperature_max_04","temperature_max_04","WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Apr","max T Apr","april","degrees Celsius","*degree*C*", +"temperature_max_05","temperature_max_05","WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature May","max T May","may","degrees Celsius","*degree*C*", +"temperature_max_06","temperature_max_06","WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jun","max T Jun","june","degrees Celsius","*degree*C*", +"temperature_max_07","temperature_max_07","WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jul","max T Jul","july","degrees Celsius","*degree*C*", +"temperature_max_08","temperature_max_08","WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Aug","max T Aug","august","degrees Celsius","*degree*C*", +"temperature_max_09","temperature_max_09","WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Sep","max T Sep","september","degrees Celsius","*degree*C*", +"temperature_max_10","temperature_max_10","WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Oct","max T Oct","october","degrees Celsius","*degree*C*", +"temperature_max_11","temperature_max_11","WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Nov","max T Nov","november","degrees Celsius","*degree*C*", +"temperature_max_12","temperature_max_12","WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Dec","max T Dec","december","degrees Celsius","*degree*C*", +"bio01","bio01","WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual mean temperature","ann. mean T","year","degrees Celsius","*degree*C*", +"bio02","bio02","WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean diurnal range","diurn. range","year","degrees Celsius","*degree*C*", +"bio03","bio03","WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","isothermality","isothermality","year","","", +"bio04","bio04","WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature seasonality","T season.","year","degrees Celsius","*degree*C*", +"bio05","bio05","WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature of warmest month","max. T of warmest mo.","year","degrees Celsius","*degree*C*", +"bio06","bio06","WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature of coldest month","min. T of coldest mo.","year","degrees Celsius","*degree*C*", +"bio07","bio07","WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature annual range (bio05-bio06)","T ann. Range","year","degrees Celsius","*degree*C*", +"bio08","bio08","WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of wettest quarter","mean T of wettest qtr","year","degrees Celsius","*degree*C*", +"bio09","bio09","WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of driest quarter","mean T of driest qtr","year","degrees Celsius","*degree*C*", +"bio10","bio10","WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of warmest quarter","mean T of warmest qtr","year","degrees Celsius","*degree*C*", +"bio11","bio11","WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of coldest quarter","mean T of coldest qtr","year","degrees Celsius","*degree*C*", +"bio12","bio12","WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual precipitation","ann. P","year","mm per year","*mm~yr^-1*", +"bio13","bio13","WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest month","P of wettest mo.","year","mm per month","*mm~mo^-1*", +"bio14","bio14","WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest month","P of driest mo.","year","mm per month","*mm~mo^-1*", +"bio15","bio15","WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation seasonality (coeff var)","P season.","year","","", +"bio16","bio16","WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest quarter","P of wettest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio17","bio17","WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest quarter","P of driest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio18","bio18","WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of warmest quarter","P of warmest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio19","bio19","WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of coldest quarter","P of coldest qtr","year","mm per quarter","*mm~qtr^-1*", +"precipitation_01","precipitation_01","WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jan","P Jan","january","mm per month","*mm~mo^-1*", +"precipitation_02","precipitation_02","WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Feb","P Feb","february","mm per month","*mm~mo^-1*", +"precipitation_03","precipitation_03","WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Mar","P Mar","march","mm per month","*mm~mo^-1*", +"precipitation_04","precipitation_04","WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Apr","P Apr","april","mm per month","*mm~mo^-1*", +"precipitation_05","precipitation_05","WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation May","P May","may","mm per month","*mm~mo^-1*", +"precipitation_06","precipitation_06","WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jun","P Jun","june","mm per month","*mm~mo^-1*", +"precipitation_07","precipitation_07","WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jul","P Jul","july","mm per month","*mm~mo^-1*", +"precipitation_08","precipitation_08","WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Aug","P Aug","august","mm per month","*mm~mo^-1*", +"precipitation_09","precipitation_09","WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Sep","P Sep","september","mm per month","*mm~mo^-1*", +"precipitation_10","precipitation_10","WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Oct","P Oct","october","mm per month","*mm~mo^-1*", +"precipitation_11","precipitation_11","WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Nov","P Nov","november","mm per month","*mm~mo^-1*", +"precipitation_12","precipitation_12","WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Dec","P Dec","december","mm per month","*mm~mo^-1*", +"temperature_min_01","temperature_min_01","WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jan","min T Jan","january","degrees Celsius","*degree*C*", +"temperature_min_02","temperature_min_02","WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Feb","min T Feb","february","degrees Celsius","*degree*C*", +"temperature_min_03","temperature_min_03","WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Mar","min T Mar","march","degrees Celsius","*degree*C*", +"temperature_min_04","temperature_min_04","WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Apr","min T Apr","april","degrees Celsius","*degree*C*", +"temperature_min_05","temperature_min_05","WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature May","min T May","may","degrees Celsius","*degree*C*", +"temperature_min_06","temperature_min_06","WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jun","min T Jun","june","degrees Celsius","*degree*C*", +"temperature_min_07","temperature_min_07","WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jul","min T Jul","july","degrees Celsius","*degree*C*", +"temperature_min_08","temperature_min_08","WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Aug","min T Aug","august","degrees Celsius","*degree*C*", +"temperature_min_09","temperature_min_09","WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Sep","min T Sep","september","degrees Celsius","*degree*C*", +"temperature_min_10","temperature_min_10","WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Oct","min T Oct","october","degrees Celsius","*degree*C*", +"temperature_min_11","temperature_min_11","WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Nov","min T Nov","november","degrees Celsius","*degree*C*", +"temperature_min_12","temperature_min_12","WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Dec","min T Dec","december","degrees Celsius","*degree*C*", +"temperature_max_01","temperature_max_01","WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jan","max T Jan","january","degrees Celsius","*degree*C*", +"temperature_max_02","temperature_max_02","WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Feb","max T Feb","february","degrees Celsius","*degree*C*", +"temperature_max_03","temperature_max_03","WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Mar","max T Mar","march","degrees Celsius","*degree*C*", +"temperature_max_04","temperature_max_04","WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Apr","max T Apr","april","degrees Celsius","*degree*C*", +"temperature_max_05","temperature_max_05","WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature May","max T May","may","degrees Celsius","*degree*C*", +"temperature_max_06","temperature_max_06","WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jun","max T Jun","june","degrees Celsius","*degree*C*", +"temperature_max_07","temperature_max_07","WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jul","max T Jul","july","degrees Celsius","*degree*C*", +"temperature_max_08","temperature_max_08","WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Aug","max T Aug","august","degrees Celsius","*degree*C*", +"temperature_max_09","temperature_max_09","WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Sep","max T Sep","september","degrees Celsius","*degree*C*", +"temperature_max_10","temperature_max_10","WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Oct","max T Oct","october","degrees Celsius","*degree*C*", +"temperature_max_11","temperature_max_11","WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Nov","max T Nov","november","degrees Celsius","*degree*C*", +"temperature_max_12","temperature_max_12","WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Dec","max T Dec","december","degrees Celsius","*degree*C*", +"bio01","bio01","WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual mean temperature","ann. mean T","year","degrees Celsius","*degree*C*", +"bio02","bio02","WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean diurnal range","diurn. range","year","degrees Celsius","*degree*C*", +"bio03","bio03","WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","isothermality","isothermality","year","","", +"bio04","bio04","WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature seasonality","T season.","year","degrees Celsius","*degree*C*", +"bio05","bio05","WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature of warmest month","max. T of warmest mo.","year","degrees Celsius","*degree*C*", +"bio06","bio06","WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature of coldest month","min. T of coldest mo.","year","degrees Celsius","*degree*C*", +"bio07","bio07","WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature annual range (bio05-bio06)","T ann. Range","year","degrees Celsius","*degree*C*", +"bio08","bio08","WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of wettest quarter","mean T of wettest qtr","year","degrees Celsius","*degree*C*", +"bio09","bio09","WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of driest quarter","mean T of driest qtr","year","degrees Celsius","*degree*C*", +"bio10","bio10","WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of warmest quarter","mean T of warmest qtr","year","degrees Celsius","*degree*C*", +"bio11","bio11","WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of coldest quarter","mean T of coldest qtr","year","degrees Celsius","*degree*C*", +"bio12","bio12","WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual precipitation","ann. P","year","mm per year","*mm~yr^-1*", +"bio13","bio13","WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest month","P of wettest mo.","year","mm per month","*mm~mo^-1*", +"bio14","bio14","WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest month","P of driest mo.","year","mm per month","*mm~mo^-1*", +"bio15","bio15","WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation seasonality (coeff var)","P season.","year","","", +"bio16","bio16","WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest quarter","P of wettest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio17","bio17","WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest quarter","P of driest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio18","bio18","WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of warmest quarter","P of warmest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio19","bio19","WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of coldest quarter","P of coldest qtr","year","mm per quarter","*mm~qtr^-1*", +"precipitation_01","precipitation_01","WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jan","P Jan","january","mm per month","*mm~mo^-1*", +"precipitation_02","precipitation_02","WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Feb","P Feb","february","mm per month","*mm~mo^-1*", +"precipitation_03","precipitation_03","WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Mar","P Mar","march","mm per month","*mm~mo^-1*", +"precipitation_04","precipitation_04","WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Apr","P Apr","april","mm per month","*mm~mo^-1*", +"precipitation_05","precipitation_05","WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation May","P May","may","mm per month","*mm~mo^-1*", +"precipitation_06","precipitation_06","WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jun","P Jun","june","mm per month","*mm~mo^-1*", +"precipitation_07","precipitation_07","WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jul","P Jul","july","mm per month","*mm~mo^-1*", +"precipitation_08","precipitation_08","WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Aug","P Aug","august","mm per month","*mm~mo^-1*", +"precipitation_09","precipitation_09","WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Sep","P Sep","september","mm per month","*mm~mo^-1*", +"precipitation_10","precipitation_10","WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Oct","P Oct","october","mm per month","*mm~mo^-1*", +"precipitation_11","precipitation_11","WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Nov","P Nov","november","mm per month","*mm~mo^-1*", +"precipitation_12","precipitation_12","WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Dec","P Dec","december","mm per month","*mm~mo^-1*", +"temperature_min_01","temperature_min_01","WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jan","min T Jan","january","degrees Celsius","*degree*C*", +"temperature_min_02","temperature_min_02","WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Feb","min T Feb","february","degrees Celsius","*degree*C*", +"temperature_min_03","temperature_min_03","WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Mar","min T Mar","march","degrees Celsius","*degree*C*", +"temperature_min_04","temperature_min_04","WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Apr","min T Apr","april","degrees Celsius","*degree*C*", +"temperature_min_05","temperature_min_05","WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature May","min T May","may","degrees Celsius","*degree*C*", +"temperature_min_06","temperature_min_06","WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jun","min T Jun","june","degrees Celsius","*degree*C*", +"temperature_min_07","temperature_min_07","WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jul","min T Jul","july","degrees Celsius","*degree*C*", +"temperature_min_08","temperature_min_08","WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Aug","min T Aug","august","degrees Celsius","*degree*C*", +"temperature_min_09","temperature_min_09","WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Sep","min T Sep","september","degrees Celsius","*degree*C*", +"temperature_min_10","temperature_min_10","WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Oct","min T Oct","october","degrees Celsius","*degree*C*", +"temperature_min_11","temperature_min_11","WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Nov","min T Nov","november","degrees Celsius","*degree*C*", +"temperature_min_12","temperature_min_12","WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Dec","min T Dec","december","degrees Celsius","*degree*C*", +"temperature_max_01","temperature_max_01","WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jan","max T Jan","january","degrees Celsius","*degree*C*", +"temperature_max_02","temperature_max_02","WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Feb","max T Feb","february","degrees Celsius","*degree*C*", +"temperature_max_03","temperature_max_03","WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Mar","max T Mar","march","degrees Celsius","*degree*C*", +"temperature_max_04","temperature_max_04","WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Apr","max T Apr","april","degrees Celsius","*degree*C*", +"temperature_max_05","temperature_max_05","WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature May","max T May","may","degrees Celsius","*degree*C*", +"temperature_max_06","temperature_max_06","WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jun","max T Jun","june","degrees Celsius","*degree*C*", +"temperature_max_07","temperature_max_07","WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jul","max T Jul","july","degrees Celsius","*degree*C*", +"temperature_max_08","temperature_max_08","WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Aug","max T Aug","august","degrees Celsius","*degree*C*", +"temperature_max_09","temperature_max_09","WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Sep","max T Sep","september","degrees Celsius","*degree*C*", +"temperature_max_10","temperature_max_10","WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Oct","max T Oct","october","degrees Celsius","*degree*C*", +"temperature_max_11","temperature_max_11","WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Nov","max T Nov","november","degrees Celsius","*degree*C*", +"temperature_max_12","temperature_max_12","WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Dec","max T Dec","december","degrees Celsius","*degree*C*", +"bio01","bio01","WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual mean temperature","ann. mean T","year","degrees Celsius","*degree*C*", +"bio02","bio02","WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean diurnal range","diurn. range","year","degrees Celsius","*degree*C*", +"bio03","bio03","WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","isothermality","isothermality","year","","", +"bio04","bio04","WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature seasonality","T season.","year","degrees Celsius","*degree*C*", +"bio05","bio05","WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature of warmest month","max. T of warmest mo.","year","degrees Celsius","*degree*C*", +"bio06","bio06","WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature of coldest month","min. T of coldest mo.","year","degrees Celsius","*degree*C*", +"bio07","bio07","WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature annual range (bio05-bio06)","T ann. Range","year","degrees Celsius","*degree*C*", +"bio08","bio08","WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of wettest quarter","mean T of wettest qtr","year","degrees Celsius","*degree*C*", +"bio09","bio09","WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of driest quarter","mean T of driest qtr","year","degrees Celsius","*degree*C*", +"bio10","bio10","WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of warmest quarter","mean T of warmest qtr","year","degrees Celsius","*degree*C*", +"bio11","bio11","WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of coldest quarter","mean T of coldest qtr","year","degrees Celsius","*degree*C*", +"bio12","bio12","WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual precipitation","ann. P","year","mm per year","*mm~yr^-1*", +"bio13","bio13","WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest month","P of wettest mo.","year","mm per month","*mm~mo^-1*", +"bio14","bio14","WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest month","P of driest mo.","year","mm per month","*mm~mo^-1*", +"bio15","bio15","WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation seasonality (coeff var)","P season.","year","","", +"bio16","bio16","WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest quarter","P of wettest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio17","bio17","WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest quarter","P of driest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio18","bio18","WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of warmest quarter","P of warmest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio19","bio19","WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m",FALSE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of coldest quarter","P of coldest qtr","year","mm per quarter","*mm~qtr^-1*", +"precipitation_01","precipitation_01","WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jan","P Jan","january","mm per month","*mm~mo^-1*", +"precipitation_02","precipitation_02","WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Feb","P Feb","february","mm per month","*mm~mo^-1*", +"precipitation_03","precipitation_03","WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Mar","P Mar","march","mm per month","*mm~mo^-1*", +"precipitation_04","precipitation_04","WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Apr","P Apr","april","mm per month","*mm~mo^-1*", +"precipitation_05","precipitation_05","WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation May","P May","may","mm per month","*mm~mo^-1*", +"precipitation_06","precipitation_06","WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jun","P Jun","june","mm per month","*mm~mo^-1*", +"precipitation_07","precipitation_07","WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jul","P Jul","july","mm per month","*mm~mo^-1*", +"precipitation_08","precipitation_08","WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Aug","P Aug","august","mm per month","*mm~mo^-1*", +"precipitation_09","precipitation_09","WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Sep","P Sep","september","mm per month","*mm~mo^-1*", +"precipitation_10","precipitation_10","WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Oct","P Oct","october","mm per month","*mm~mo^-1*", +"precipitation_11","precipitation_11","WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Nov","P Nov","november","mm per month","*mm~mo^-1*", +"precipitation_12","precipitation_12","WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Dec","P Dec","december","mm per month","*mm~mo^-1*", +"temperature_min_01","temperature_min_01","WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jan","min T Jan","january","degrees Celsius","*degree*C*", +"temperature_min_02","temperature_min_02","WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Feb","min T Feb","february","degrees Celsius","*degree*C*", +"temperature_min_03","temperature_min_03","WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Mar","min T Mar","march","degrees Celsius","*degree*C*", +"temperature_min_04","temperature_min_04","WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Apr","min T Apr","april","degrees Celsius","*degree*C*", +"temperature_min_05","temperature_min_05","WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature May","min T May","may","degrees Celsius","*degree*C*", +"temperature_min_06","temperature_min_06","WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jun","min T Jun","june","degrees Celsius","*degree*C*", +"temperature_min_07","temperature_min_07","WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jul","min T Jul","july","degrees Celsius","*degree*C*", +"temperature_min_08","temperature_min_08","WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Aug","min T Aug","august","degrees Celsius","*degree*C*", +"temperature_min_09","temperature_min_09","WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Sep","min T Sep","september","degrees Celsius","*degree*C*", +"temperature_min_10","temperature_min_10","WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Oct","min T Oct","october","degrees Celsius","*degree*C*", +"temperature_min_11","temperature_min_11","WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Nov","min T Nov","november","degrees Celsius","*degree*C*", +"temperature_min_12","temperature_min_12","WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Dec","min T Dec","december","degrees Celsius","*degree*C*", +"temperature_max_01","temperature_max_01","WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jan","max T Jan","january","degrees Celsius","*degree*C*", +"temperature_max_02","temperature_max_02","WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Feb","max T Feb","february","degrees Celsius","*degree*C*", +"temperature_max_03","temperature_max_03","WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Mar","max T Mar","march","degrees Celsius","*degree*C*", +"temperature_max_04","temperature_max_04","WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Apr","max T Apr","april","degrees Celsius","*degree*C*", +"temperature_max_05","temperature_max_05","WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature May","max T May","may","degrees Celsius","*degree*C*", +"temperature_max_06","temperature_max_06","WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jun","max T Jun","june","degrees Celsius","*degree*C*", +"temperature_max_07","temperature_max_07","WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jul","max T Jul","july","degrees Celsius","*degree*C*", +"temperature_max_08","temperature_max_08","WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Aug","max T Aug","august","degrees Celsius","*degree*C*", +"temperature_max_09","temperature_max_09","WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Sep","max T Sep","september","degrees Celsius","*degree*C*", +"temperature_max_10","temperature_max_10","WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Oct","max T Oct","october","degrees Celsius","*degree*C*", +"temperature_max_11","temperature_max_11","WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Nov","max T Nov","november","degrees Celsius","*degree*C*", +"temperature_max_12","temperature_max_12","WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m",TRUE,"WorldClim_2.1_MPI-ESM1-2-HR_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Dec","max T Dec","december","degrees Celsius","*degree*C*", +"bio01","bio01","WorldClim_2.1_MRI-ESM2-0_ssp126_10m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual mean temperature","ann. mean T","year","degrees Celsius","*degree*C*", +"bio02","bio02","WorldClim_2.1_MRI-ESM2-0_ssp126_10m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean diurnal range","diurn. range","year","degrees Celsius","*degree*C*", +"bio03","bio03","WorldClim_2.1_MRI-ESM2-0_ssp126_10m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","isothermality","isothermality","year","","", +"bio04","bio04","WorldClim_2.1_MRI-ESM2-0_ssp126_10m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature seasonality","T season.","year","degrees Celsius","*degree*C*", +"bio05","bio05","WorldClim_2.1_MRI-ESM2-0_ssp126_10m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature of warmest month","max. T of warmest mo.","year","degrees Celsius","*degree*C*", +"bio06","bio06","WorldClim_2.1_MRI-ESM2-0_ssp126_10m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature of coldest month","min. T of coldest mo.","year","degrees Celsius","*degree*C*", +"bio07","bio07","WorldClim_2.1_MRI-ESM2-0_ssp126_10m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature annual range (bio05-bio06)","T ann. Range","year","degrees Celsius","*degree*C*", +"bio08","bio08","WorldClim_2.1_MRI-ESM2-0_ssp126_10m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of wettest quarter","mean T of wettest qtr","year","degrees Celsius","*degree*C*", +"bio09","bio09","WorldClim_2.1_MRI-ESM2-0_ssp126_10m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of driest quarter","mean T of driest qtr","year","degrees Celsius","*degree*C*", +"bio10","bio10","WorldClim_2.1_MRI-ESM2-0_ssp126_10m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of warmest quarter","mean T of warmest qtr","year","degrees Celsius","*degree*C*", +"bio11","bio11","WorldClim_2.1_MRI-ESM2-0_ssp126_10m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of coldest quarter","mean T of coldest qtr","year","degrees Celsius","*degree*C*", +"bio12","bio12","WorldClim_2.1_MRI-ESM2-0_ssp126_10m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual precipitation","ann. P","year","mm per year","*mm~yr^-1*", +"bio13","bio13","WorldClim_2.1_MRI-ESM2-0_ssp126_10m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest month","P of wettest mo.","year","mm per month","*mm~mo^-1*", +"bio14","bio14","WorldClim_2.1_MRI-ESM2-0_ssp126_10m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest month","P of driest mo.","year","mm per month","*mm~mo^-1*", +"bio15","bio15","WorldClim_2.1_MRI-ESM2-0_ssp126_10m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation seasonality (coeff var)","P season.","year","","", +"bio16","bio16","WorldClim_2.1_MRI-ESM2-0_ssp126_10m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest quarter","P of wettest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio17","bio17","WorldClim_2.1_MRI-ESM2-0_ssp126_10m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest quarter","P of driest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio18","bio18","WorldClim_2.1_MRI-ESM2-0_ssp126_10m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of warmest quarter","P of warmest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio19","bio19","WorldClim_2.1_MRI-ESM2-0_ssp126_10m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of coldest quarter","P of coldest qtr","year","mm per quarter","*mm~qtr^-1*", +"precipitation_01","precipitation_01","WorldClim_2.1_MRI-ESM2-0_ssp126_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jan","P Jan","january","mm per month","*mm~mo^-1*", +"precipitation_02","precipitation_02","WorldClim_2.1_MRI-ESM2-0_ssp126_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Feb","P Feb","february","mm per month","*mm~mo^-1*", +"precipitation_03","precipitation_03","WorldClim_2.1_MRI-ESM2-0_ssp126_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Mar","P Mar","march","mm per month","*mm~mo^-1*", +"precipitation_04","precipitation_04","WorldClim_2.1_MRI-ESM2-0_ssp126_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Apr","P Apr","april","mm per month","*mm~mo^-1*", +"precipitation_05","precipitation_05","WorldClim_2.1_MRI-ESM2-0_ssp126_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation May","P May","may","mm per month","*mm~mo^-1*", +"precipitation_06","precipitation_06","WorldClim_2.1_MRI-ESM2-0_ssp126_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jun","P Jun","june","mm per month","*mm~mo^-1*", +"precipitation_07","precipitation_07","WorldClim_2.1_MRI-ESM2-0_ssp126_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jul","P Jul","july","mm per month","*mm~mo^-1*", +"precipitation_08","precipitation_08","WorldClim_2.1_MRI-ESM2-0_ssp126_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Aug","P Aug","august","mm per month","*mm~mo^-1*", +"precipitation_09","precipitation_09","WorldClim_2.1_MRI-ESM2-0_ssp126_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Sep","P Sep","september","mm per month","*mm~mo^-1*", +"precipitation_10","precipitation_10","WorldClim_2.1_MRI-ESM2-0_ssp126_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Oct","P Oct","october","mm per month","*mm~mo^-1*", +"precipitation_11","precipitation_11","WorldClim_2.1_MRI-ESM2-0_ssp126_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Nov","P Nov","november","mm per month","*mm~mo^-1*", +"precipitation_12","precipitation_12","WorldClim_2.1_MRI-ESM2-0_ssp126_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Dec","P Dec","december","mm per month","*mm~mo^-1*", +"temperature_min_01","temperature_min_01","WorldClim_2.1_MRI-ESM2-0_ssp126_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jan","min T Jan","january","degrees Celsius","*degree*C*", +"temperature_min_02","temperature_min_02","WorldClim_2.1_MRI-ESM2-0_ssp126_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Feb","min T Feb","february","degrees Celsius","*degree*C*", +"temperature_min_03","temperature_min_03","WorldClim_2.1_MRI-ESM2-0_ssp126_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Mar","min T Mar","march","degrees Celsius","*degree*C*", +"temperature_min_04","temperature_min_04","WorldClim_2.1_MRI-ESM2-0_ssp126_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Apr","min T Apr","april","degrees Celsius","*degree*C*", +"temperature_min_05","temperature_min_05","WorldClim_2.1_MRI-ESM2-0_ssp126_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature May","min T May","may","degrees Celsius","*degree*C*", +"temperature_min_06","temperature_min_06","WorldClim_2.1_MRI-ESM2-0_ssp126_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jun","min T Jun","june","degrees Celsius","*degree*C*", +"temperature_min_07","temperature_min_07","WorldClim_2.1_MRI-ESM2-0_ssp126_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jul","min T Jul","july","degrees Celsius","*degree*C*", +"temperature_min_08","temperature_min_08","WorldClim_2.1_MRI-ESM2-0_ssp126_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Aug","min T Aug","august","degrees Celsius","*degree*C*", +"temperature_min_09","temperature_min_09","WorldClim_2.1_MRI-ESM2-0_ssp126_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Sep","min T Sep","september","degrees Celsius","*degree*C*", +"temperature_min_10","temperature_min_10","WorldClim_2.1_MRI-ESM2-0_ssp126_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Oct","min T Oct","october","degrees Celsius","*degree*C*", +"temperature_min_11","temperature_min_11","WorldClim_2.1_MRI-ESM2-0_ssp126_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Nov","min T Nov","november","degrees Celsius","*degree*C*", +"temperature_min_12","temperature_min_12","WorldClim_2.1_MRI-ESM2-0_ssp126_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Dec","min T Dec","december","degrees Celsius","*degree*C*", +"temperature_max_01","temperature_max_01","WorldClim_2.1_MRI-ESM2-0_ssp126_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jan","max T Jan","january","degrees Celsius","*degree*C*", +"temperature_max_02","temperature_max_02","WorldClim_2.1_MRI-ESM2-0_ssp126_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Feb","max T Feb","february","degrees Celsius","*degree*C*", +"temperature_max_03","temperature_max_03","WorldClim_2.1_MRI-ESM2-0_ssp126_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Mar","max T Mar","march","degrees Celsius","*degree*C*", +"temperature_max_04","temperature_max_04","WorldClim_2.1_MRI-ESM2-0_ssp126_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Apr","max T Apr","april","degrees Celsius","*degree*C*", +"temperature_max_05","temperature_max_05","WorldClim_2.1_MRI-ESM2-0_ssp126_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature May","max T May","may","degrees Celsius","*degree*C*", +"temperature_max_06","temperature_max_06","WorldClim_2.1_MRI-ESM2-0_ssp126_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jun","max T Jun","june","degrees Celsius","*degree*C*", +"temperature_max_07","temperature_max_07","WorldClim_2.1_MRI-ESM2-0_ssp126_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jul","max T Jul","july","degrees Celsius","*degree*C*", +"temperature_max_08","temperature_max_08","WorldClim_2.1_MRI-ESM2-0_ssp126_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Aug","max T Aug","august","degrees Celsius","*degree*C*", +"temperature_max_09","temperature_max_09","WorldClim_2.1_MRI-ESM2-0_ssp126_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Sep","max T Sep","september","degrees Celsius","*degree*C*", +"temperature_max_10","temperature_max_10","WorldClim_2.1_MRI-ESM2-0_ssp126_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Oct","max T Oct","october","degrees Celsius","*degree*C*", +"temperature_max_11","temperature_max_11","WorldClim_2.1_MRI-ESM2-0_ssp126_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Nov","max T Nov","november","degrees Celsius","*degree*C*", +"temperature_max_12","temperature_max_12","WorldClim_2.1_MRI-ESM2-0_ssp126_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Dec","max T Dec","december","degrees Celsius","*degree*C*", +"bio01","bio01","WorldClim_2.1_MRI-ESM2-0_ssp126_5m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual mean temperature","ann. mean T","year","degrees Celsius","*degree*C*", +"bio02","bio02","WorldClim_2.1_MRI-ESM2-0_ssp126_5m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean diurnal range","diurn. range","year","degrees Celsius","*degree*C*", +"bio03","bio03","WorldClim_2.1_MRI-ESM2-0_ssp126_5m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","isothermality","isothermality","year","","", +"bio04","bio04","WorldClim_2.1_MRI-ESM2-0_ssp126_5m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature seasonality","T season.","year","degrees Celsius","*degree*C*", +"bio05","bio05","WorldClim_2.1_MRI-ESM2-0_ssp126_5m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature of warmest month","max. T of warmest mo.","year","degrees Celsius","*degree*C*", +"bio06","bio06","WorldClim_2.1_MRI-ESM2-0_ssp126_5m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature of coldest month","min. T of coldest mo.","year","degrees Celsius","*degree*C*", +"bio07","bio07","WorldClim_2.1_MRI-ESM2-0_ssp126_5m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature annual range (bio05-bio06)","T ann. Range","year","degrees Celsius","*degree*C*", +"bio08","bio08","WorldClim_2.1_MRI-ESM2-0_ssp126_5m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of wettest quarter","mean T of wettest qtr","year","degrees Celsius","*degree*C*", +"bio09","bio09","WorldClim_2.1_MRI-ESM2-0_ssp126_5m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of driest quarter","mean T of driest qtr","year","degrees Celsius","*degree*C*", +"bio10","bio10","WorldClim_2.1_MRI-ESM2-0_ssp126_5m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of warmest quarter","mean T of warmest qtr","year","degrees Celsius","*degree*C*", +"bio11","bio11","WorldClim_2.1_MRI-ESM2-0_ssp126_5m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of coldest quarter","mean T of coldest qtr","year","degrees Celsius","*degree*C*", +"bio12","bio12","WorldClim_2.1_MRI-ESM2-0_ssp126_5m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual precipitation","ann. P","year","mm per year","*mm~yr^-1*", +"bio13","bio13","WorldClim_2.1_MRI-ESM2-0_ssp126_5m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest month","P of wettest mo.","year","mm per month","*mm~mo^-1*", +"bio14","bio14","WorldClim_2.1_MRI-ESM2-0_ssp126_5m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest month","P of driest mo.","year","mm per month","*mm~mo^-1*", +"bio15","bio15","WorldClim_2.1_MRI-ESM2-0_ssp126_5m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation seasonality (coeff var)","P season.","year","","", +"bio16","bio16","WorldClim_2.1_MRI-ESM2-0_ssp126_5m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest quarter","P of wettest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio17","bio17","WorldClim_2.1_MRI-ESM2-0_ssp126_5m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest quarter","P of driest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio18","bio18","WorldClim_2.1_MRI-ESM2-0_ssp126_5m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of warmest quarter","P of warmest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio19","bio19","WorldClim_2.1_MRI-ESM2-0_ssp126_5m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of coldest quarter","P of coldest qtr","year","mm per quarter","*mm~qtr^-1*", +"precipitation_01","precipitation_01","WorldClim_2.1_MRI-ESM2-0_ssp126_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jan","P Jan","january","mm per month","*mm~mo^-1*", +"precipitation_02","precipitation_02","WorldClim_2.1_MRI-ESM2-0_ssp126_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Feb","P Feb","february","mm per month","*mm~mo^-1*", +"precipitation_03","precipitation_03","WorldClim_2.1_MRI-ESM2-0_ssp126_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Mar","P Mar","march","mm per month","*mm~mo^-1*", +"precipitation_04","precipitation_04","WorldClim_2.1_MRI-ESM2-0_ssp126_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Apr","P Apr","april","mm per month","*mm~mo^-1*", +"precipitation_05","precipitation_05","WorldClim_2.1_MRI-ESM2-0_ssp126_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation May","P May","may","mm per month","*mm~mo^-1*", +"precipitation_06","precipitation_06","WorldClim_2.1_MRI-ESM2-0_ssp126_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jun","P Jun","june","mm per month","*mm~mo^-1*", +"precipitation_07","precipitation_07","WorldClim_2.1_MRI-ESM2-0_ssp126_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jul","P Jul","july","mm per month","*mm~mo^-1*", +"precipitation_08","precipitation_08","WorldClim_2.1_MRI-ESM2-0_ssp126_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Aug","P Aug","august","mm per month","*mm~mo^-1*", +"precipitation_09","precipitation_09","WorldClim_2.1_MRI-ESM2-0_ssp126_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Sep","P Sep","september","mm per month","*mm~mo^-1*", +"precipitation_10","precipitation_10","WorldClim_2.1_MRI-ESM2-0_ssp126_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Oct","P Oct","october","mm per month","*mm~mo^-1*", +"precipitation_11","precipitation_11","WorldClim_2.1_MRI-ESM2-0_ssp126_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Nov","P Nov","november","mm per month","*mm~mo^-1*", +"precipitation_12","precipitation_12","WorldClim_2.1_MRI-ESM2-0_ssp126_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Dec","P Dec","december","mm per month","*mm~mo^-1*", +"temperature_min_01","temperature_min_01","WorldClim_2.1_MRI-ESM2-0_ssp126_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jan","min T Jan","january","degrees Celsius","*degree*C*", +"temperature_min_02","temperature_min_02","WorldClim_2.1_MRI-ESM2-0_ssp126_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Feb","min T Feb","february","degrees Celsius","*degree*C*", +"temperature_min_03","temperature_min_03","WorldClim_2.1_MRI-ESM2-0_ssp126_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Mar","min T Mar","march","degrees Celsius","*degree*C*", +"temperature_min_04","temperature_min_04","WorldClim_2.1_MRI-ESM2-0_ssp126_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Apr","min T Apr","april","degrees Celsius","*degree*C*", +"temperature_min_05","temperature_min_05","WorldClim_2.1_MRI-ESM2-0_ssp126_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature May","min T May","may","degrees Celsius","*degree*C*", +"temperature_min_06","temperature_min_06","WorldClim_2.1_MRI-ESM2-0_ssp126_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jun","min T Jun","june","degrees Celsius","*degree*C*", +"temperature_min_07","temperature_min_07","WorldClim_2.1_MRI-ESM2-0_ssp126_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jul","min T Jul","july","degrees Celsius","*degree*C*", +"temperature_min_08","temperature_min_08","WorldClim_2.1_MRI-ESM2-0_ssp126_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Aug","min T Aug","august","degrees Celsius","*degree*C*", +"temperature_min_09","temperature_min_09","WorldClim_2.1_MRI-ESM2-0_ssp126_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Sep","min T Sep","september","degrees Celsius","*degree*C*", +"temperature_min_10","temperature_min_10","WorldClim_2.1_MRI-ESM2-0_ssp126_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Oct","min T Oct","october","degrees Celsius","*degree*C*", +"temperature_min_11","temperature_min_11","WorldClim_2.1_MRI-ESM2-0_ssp126_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Nov","min T Nov","november","degrees Celsius","*degree*C*", +"temperature_min_12","temperature_min_12","WorldClim_2.1_MRI-ESM2-0_ssp126_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Dec","min T Dec","december","degrees Celsius","*degree*C*", +"temperature_max_01","temperature_max_01","WorldClim_2.1_MRI-ESM2-0_ssp126_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jan","max T Jan","january","degrees Celsius","*degree*C*", +"temperature_max_02","temperature_max_02","WorldClim_2.1_MRI-ESM2-0_ssp126_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Feb","max T Feb","february","degrees Celsius","*degree*C*", +"temperature_max_03","temperature_max_03","WorldClim_2.1_MRI-ESM2-0_ssp126_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Mar","max T Mar","march","degrees Celsius","*degree*C*", +"temperature_max_04","temperature_max_04","WorldClim_2.1_MRI-ESM2-0_ssp126_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Apr","max T Apr","april","degrees Celsius","*degree*C*", +"temperature_max_05","temperature_max_05","WorldClim_2.1_MRI-ESM2-0_ssp126_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature May","max T May","may","degrees Celsius","*degree*C*", +"temperature_max_06","temperature_max_06","WorldClim_2.1_MRI-ESM2-0_ssp126_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jun","max T Jun","june","degrees Celsius","*degree*C*", +"temperature_max_07","temperature_max_07","WorldClim_2.1_MRI-ESM2-0_ssp126_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jul","max T Jul","july","degrees Celsius","*degree*C*", +"temperature_max_08","temperature_max_08","WorldClim_2.1_MRI-ESM2-0_ssp126_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Aug","max T Aug","august","degrees Celsius","*degree*C*", +"temperature_max_09","temperature_max_09","WorldClim_2.1_MRI-ESM2-0_ssp126_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Sep","max T Sep","september","degrees Celsius","*degree*C*", +"temperature_max_10","temperature_max_10","WorldClim_2.1_MRI-ESM2-0_ssp126_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Oct","max T Oct","october","degrees Celsius","*degree*C*", +"temperature_max_11","temperature_max_11","WorldClim_2.1_MRI-ESM2-0_ssp126_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Nov","max T Nov","november","degrees Celsius","*degree*C*", +"temperature_max_12","temperature_max_12","WorldClim_2.1_MRI-ESM2-0_ssp126_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Dec","max T Dec","december","degrees Celsius","*degree*C*", +"bio01","bio01","WorldClim_2.1_MRI-ESM2-0_ssp245_10m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual mean temperature","ann. mean T","year","degrees Celsius","*degree*C*", +"bio02","bio02","WorldClim_2.1_MRI-ESM2-0_ssp245_10m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean diurnal range","diurn. range","year","degrees Celsius","*degree*C*", +"bio03","bio03","WorldClim_2.1_MRI-ESM2-0_ssp245_10m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","isothermality","isothermality","year","","", +"bio04","bio04","WorldClim_2.1_MRI-ESM2-0_ssp245_10m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature seasonality","T season.","year","degrees Celsius","*degree*C*", +"bio05","bio05","WorldClim_2.1_MRI-ESM2-0_ssp245_10m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature of warmest month","max. T of warmest mo.","year","degrees Celsius","*degree*C*", +"bio06","bio06","WorldClim_2.1_MRI-ESM2-0_ssp245_10m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature of coldest month","min. T of coldest mo.","year","degrees Celsius","*degree*C*", +"bio07","bio07","WorldClim_2.1_MRI-ESM2-0_ssp245_10m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature annual range (bio05-bio06)","T ann. Range","year","degrees Celsius","*degree*C*", +"bio08","bio08","WorldClim_2.1_MRI-ESM2-0_ssp245_10m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of wettest quarter","mean T of wettest qtr","year","degrees Celsius","*degree*C*", +"bio09","bio09","WorldClim_2.1_MRI-ESM2-0_ssp245_10m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of driest quarter","mean T of driest qtr","year","degrees Celsius","*degree*C*", +"bio10","bio10","WorldClim_2.1_MRI-ESM2-0_ssp245_10m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of warmest quarter","mean T of warmest qtr","year","degrees Celsius","*degree*C*", +"bio11","bio11","WorldClim_2.1_MRI-ESM2-0_ssp245_10m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of coldest quarter","mean T of coldest qtr","year","degrees Celsius","*degree*C*", +"bio12","bio12","WorldClim_2.1_MRI-ESM2-0_ssp245_10m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual precipitation","ann. P","year","mm per year","*mm~yr^-1*", +"bio13","bio13","WorldClim_2.1_MRI-ESM2-0_ssp245_10m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest month","P of wettest mo.","year","mm per month","*mm~mo^-1*", +"bio14","bio14","WorldClim_2.1_MRI-ESM2-0_ssp245_10m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest month","P of driest mo.","year","mm per month","*mm~mo^-1*", +"bio15","bio15","WorldClim_2.1_MRI-ESM2-0_ssp245_10m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation seasonality (coeff var)","P season.","year","","", +"bio16","bio16","WorldClim_2.1_MRI-ESM2-0_ssp245_10m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest quarter","P of wettest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio17","bio17","WorldClim_2.1_MRI-ESM2-0_ssp245_10m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest quarter","P of driest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio18","bio18","WorldClim_2.1_MRI-ESM2-0_ssp245_10m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of warmest quarter","P of warmest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio19","bio19","WorldClim_2.1_MRI-ESM2-0_ssp245_10m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of coldest quarter","P of coldest qtr","year","mm per quarter","*mm~qtr^-1*", +"precipitation_01","precipitation_01","WorldClim_2.1_MRI-ESM2-0_ssp245_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jan","P Jan","january","mm per month","*mm~mo^-1*", +"precipitation_02","precipitation_02","WorldClim_2.1_MRI-ESM2-0_ssp245_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Feb","P Feb","february","mm per month","*mm~mo^-1*", +"precipitation_03","precipitation_03","WorldClim_2.1_MRI-ESM2-0_ssp245_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Mar","P Mar","march","mm per month","*mm~mo^-1*", +"precipitation_04","precipitation_04","WorldClim_2.1_MRI-ESM2-0_ssp245_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Apr","P Apr","april","mm per month","*mm~mo^-1*", +"precipitation_05","precipitation_05","WorldClim_2.1_MRI-ESM2-0_ssp245_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation May","P May","may","mm per month","*mm~mo^-1*", +"precipitation_06","precipitation_06","WorldClim_2.1_MRI-ESM2-0_ssp245_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jun","P Jun","june","mm per month","*mm~mo^-1*", +"precipitation_07","precipitation_07","WorldClim_2.1_MRI-ESM2-0_ssp245_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jul","P Jul","july","mm per month","*mm~mo^-1*", +"precipitation_08","precipitation_08","WorldClim_2.1_MRI-ESM2-0_ssp245_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Aug","P Aug","august","mm per month","*mm~mo^-1*", +"precipitation_09","precipitation_09","WorldClim_2.1_MRI-ESM2-0_ssp245_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Sep","P Sep","september","mm per month","*mm~mo^-1*", +"precipitation_10","precipitation_10","WorldClim_2.1_MRI-ESM2-0_ssp245_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Oct","P Oct","october","mm per month","*mm~mo^-1*", +"precipitation_11","precipitation_11","WorldClim_2.1_MRI-ESM2-0_ssp245_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Nov","P Nov","november","mm per month","*mm~mo^-1*", +"precipitation_12","precipitation_12","WorldClim_2.1_MRI-ESM2-0_ssp245_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Dec","P Dec","december","mm per month","*mm~mo^-1*", +"temperature_min_01","temperature_min_01","WorldClim_2.1_MRI-ESM2-0_ssp245_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jan","min T Jan","january","degrees Celsius","*degree*C*", +"temperature_min_02","temperature_min_02","WorldClim_2.1_MRI-ESM2-0_ssp245_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Feb","min T Feb","february","degrees Celsius","*degree*C*", +"temperature_min_03","temperature_min_03","WorldClim_2.1_MRI-ESM2-0_ssp245_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Mar","min T Mar","march","degrees Celsius","*degree*C*", +"temperature_min_04","temperature_min_04","WorldClim_2.1_MRI-ESM2-0_ssp245_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Apr","min T Apr","april","degrees Celsius","*degree*C*", +"temperature_min_05","temperature_min_05","WorldClim_2.1_MRI-ESM2-0_ssp245_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature May","min T May","may","degrees Celsius","*degree*C*", +"temperature_min_06","temperature_min_06","WorldClim_2.1_MRI-ESM2-0_ssp245_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jun","min T Jun","june","degrees Celsius","*degree*C*", +"temperature_min_07","temperature_min_07","WorldClim_2.1_MRI-ESM2-0_ssp245_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jul","min T Jul","july","degrees Celsius","*degree*C*", +"temperature_min_08","temperature_min_08","WorldClim_2.1_MRI-ESM2-0_ssp245_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Aug","min T Aug","august","degrees Celsius","*degree*C*", +"temperature_min_09","temperature_min_09","WorldClim_2.1_MRI-ESM2-0_ssp245_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Sep","min T Sep","september","degrees Celsius","*degree*C*", +"temperature_min_10","temperature_min_10","WorldClim_2.1_MRI-ESM2-0_ssp245_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Oct","min T Oct","october","degrees Celsius","*degree*C*", +"temperature_min_11","temperature_min_11","WorldClim_2.1_MRI-ESM2-0_ssp245_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Nov","min T Nov","november","degrees Celsius","*degree*C*", +"temperature_min_12","temperature_min_12","WorldClim_2.1_MRI-ESM2-0_ssp245_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Dec","min T Dec","december","degrees Celsius","*degree*C*", +"temperature_max_01","temperature_max_01","WorldClim_2.1_MRI-ESM2-0_ssp245_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jan","max T Jan","january","degrees Celsius","*degree*C*", +"temperature_max_02","temperature_max_02","WorldClim_2.1_MRI-ESM2-0_ssp245_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Feb","max T Feb","february","degrees Celsius","*degree*C*", +"temperature_max_03","temperature_max_03","WorldClim_2.1_MRI-ESM2-0_ssp245_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Mar","max T Mar","march","degrees Celsius","*degree*C*", +"temperature_max_04","temperature_max_04","WorldClim_2.1_MRI-ESM2-0_ssp245_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Apr","max T Apr","april","degrees Celsius","*degree*C*", +"temperature_max_05","temperature_max_05","WorldClim_2.1_MRI-ESM2-0_ssp245_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature May","max T May","may","degrees Celsius","*degree*C*", +"temperature_max_06","temperature_max_06","WorldClim_2.1_MRI-ESM2-0_ssp245_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jun","max T Jun","june","degrees Celsius","*degree*C*", +"temperature_max_07","temperature_max_07","WorldClim_2.1_MRI-ESM2-0_ssp245_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jul","max T Jul","july","degrees Celsius","*degree*C*", +"temperature_max_08","temperature_max_08","WorldClim_2.1_MRI-ESM2-0_ssp245_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Aug","max T Aug","august","degrees Celsius","*degree*C*", +"temperature_max_09","temperature_max_09","WorldClim_2.1_MRI-ESM2-0_ssp245_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Sep","max T Sep","september","degrees Celsius","*degree*C*", +"temperature_max_10","temperature_max_10","WorldClim_2.1_MRI-ESM2-0_ssp245_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Oct","max T Oct","october","degrees Celsius","*degree*C*", +"temperature_max_11","temperature_max_11","WorldClim_2.1_MRI-ESM2-0_ssp245_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Nov","max T Nov","november","degrees Celsius","*degree*C*", +"temperature_max_12","temperature_max_12","WorldClim_2.1_MRI-ESM2-0_ssp245_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Dec","max T Dec","december","degrees Celsius","*degree*C*", +"bio01","bio01","WorldClim_2.1_MRI-ESM2-0_ssp245_5m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual mean temperature","ann. mean T","year","degrees Celsius","*degree*C*", +"bio02","bio02","WorldClim_2.1_MRI-ESM2-0_ssp245_5m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean diurnal range","diurn. range","year","degrees Celsius","*degree*C*", +"bio03","bio03","WorldClim_2.1_MRI-ESM2-0_ssp245_5m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","isothermality","isothermality","year","","", +"bio04","bio04","WorldClim_2.1_MRI-ESM2-0_ssp245_5m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature seasonality","T season.","year","degrees Celsius","*degree*C*", +"bio05","bio05","WorldClim_2.1_MRI-ESM2-0_ssp245_5m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature of warmest month","max. T of warmest mo.","year","degrees Celsius","*degree*C*", +"bio06","bio06","WorldClim_2.1_MRI-ESM2-0_ssp245_5m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature of coldest month","min. T of coldest mo.","year","degrees Celsius","*degree*C*", +"bio07","bio07","WorldClim_2.1_MRI-ESM2-0_ssp245_5m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature annual range (bio05-bio06)","T ann. Range","year","degrees Celsius","*degree*C*", +"bio08","bio08","WorldClim_2.1_MRI-ESM2-0_ssp245_5m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of wettest quarter","mean T of wettest qtr","year","degrees Celsius","*degree*C*", +"bio09","bio09","WorldClim_2.1_MRI-ESM2-0_ssp245_5m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of driest quarter","mean T of driest qtr","year","degrees Celsius","*degree*C*", +"bio10","bio10","WorldClim_2.1_MRI-ESM2-0_ssp245_5m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of warmest quarter","mean T of warmest qtr","year","degrees Celsius","*degree*C*", +"bio11","bio11","WorldClim_2.1_MRI-ESM2-0_ssp245_5m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of coldest quarter","mean T of coldest qtr","year","degrees Celsius","*degree*C*", +"bio12","bio12","WorldClim_2.1_MRI-ESM2-0_ssp245_5m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual precipitation","ann. P","year","mm per year","*mm~yr^-1*", +"bio13","bio13","WorldClim_2.1_MRI-ESM2-0_ssp245_5m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest month","P of wettest mo.","year","mm per month","*mm~mo^-1*", +"bio14","bio14","WorldClim_2.1_MRI-ESM2-0_ssp245_5m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest month","P of driest mo.","year","mm per month","*mm~mo^-1*", +"bio15","bio15","WorldClim_2.1_MRI-ESM2-0_ssp245_5m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation seasonality (coeff var)","P season.","year","","", +"bio16","bio16","WorldClim_2.1_MRI-ESM2-0_ssp245_5m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest quarter","P of wettest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio17","bio17","WorldClim_2.1_MRI-ESM2-0_ssp245_5m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest quarter","P of driest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio18","bio18","WorldClim_2.1_MRI-ESM2-0_ssp245_5m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of warmest quarter","P of warmest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio19","bio19","WorldClim_2.1_MRI-ESM2-0_ssp245_5m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of coldest quarter","P of coldest qtr","year","mm per quarter","*mm~qtr^-1*", +"precipitation_01","precipitation_01","WorldClim_2.1_MRI-ESM2-0_ssp245_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jan","P Jan","january","mm per month","*mm~mo^-1*", +"precipitation_02","precipitation_02","WorldClim_2.1_MRI-ESM2-0_ssp245_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Feb","P Feb","february","mm per month","*mm~mo^-1*", +"precipitation_03","precipitation_03","WorldClim_2.1_MRI-ESM2-0_ssp245_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Mar","P Mar","march","mm per month","*mm~mo^-1*", +"precipitation_04","precipitation_04","WorldClim_2.1_MRI-ESM2-0_ssp245_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Apr","P Apr","april","mm per month","*mm~mo^-1*", +"precipitation_05","precipitation_05","WorldClim_2.1_MRI-ESM2-0_ssp245_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation May","P May","may","mm per month","*mm~mo^-1*", +"precipitation_06","precipitation_06","WorldClim_2.1_MRI-ESM2-0_ssp245_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jun","P Jun","june","mm per month","*mm~mo^-1*", +"precipitation_07","precipitation_07","WorldClim_2.1_MRI-ESM2-0_ssp245_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jul","P Jul","july","mm per month","*mm~mo^-1*", +"precipitation_08","precipitation_08","WorldClim_2.1_MRI-ESM2-0_ssp245_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Aug","P Aug","august","mm per month","*mm~mo^-1*", +"precipitation_09","precipitation_09","WorldClim_2.1_MRI-ESM2-0_ssp245_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Sep","P Sep","september","mm per month","*mm~mo^-1*", +"precipitation_10","precipitation_10","WorldClim_2.1_MRI-ESM2-0_ssp245_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Oct","P Oct","october","mm per month","*mm~mo^-1*", +"precipitation_11","precipitation_11","WorldClim_2.1_MRI-ESM2-0_ssp245_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Nov","P Nov","november","mm per month","*mm~mo^-1*", +"precipitation_12","precipitation_12","WorldClim_2.1_MRI-ESM2-0_ssp245_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Dec","P Dec","december","mm per month","*mm~mo^-1*", +"temperature_min_01","temperature_min_01","WorldClim_2.1_MRI-ESM2-0_ssp245_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jan","min T Jan","january","degrees Celsius","*degree*C*", +"temperature_min_02","temperature_min_02","WorldClim_2.1_MRI-ESM2-0_ssp245_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Feb","min T Feb","february","degrees Celsius","*degree*C*", +"temperature_min_03","temperature_min_03","WorldClim_2.1_MRI-ESM2-0_ssp245_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Mar","min T Mar","march","degrees Celsius","*degree*C*", +"temperature_min_04","temperature_min_04","WorldClim_2.1_MRI-ESM2-0_ssp245_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Apr","min T Apr","april","degrees Celsius","*degree*C*", +"temperature_min_05","temperature_min_05","WorldClim_2.1_MRI-ESM2-0_ssp245_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature May","min T May","may","degrees Celsius","*degree*C*", +"temperature_min_06","temperature_min_06","WorldClim_2.1_MRI-ESM2-0_ssp245_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jun","min T Jun","june","degrees Celsius","*degree*C*", +"temperature_min_07","temperature_min_07","WorldClim_2.1_MRI-ESM2-0_ssp245_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jul","min T Jul","july","degrees Celsius","*degree*C*", +"temperature_min_08","temperature_min_08","WorldClim_2.1_MRI-ESM2-0_ssp245_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Aug","min T Aug","august","degrees Celsius","*degree*C*", +"temperature_min_09","temperature_min_09","WorldClim_2.1_MRI-ESM2-0_ssp245_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Sep","min T Sep","september","degrees Celsius","*degree*C*", +"temperature_min_10","temperature_min_10","WorldClim_2.1_MRI-ESM2-0_ssp245_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Oct","min T Oct","october","degrees Celsius","*degree*C*", +"temperature_min_11","temperature_min_11","WorldClim_2.1_MRI-ESM2-0_ssp245_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Nov","min T Nov","november","degrees Celsius","*degree*C*", +"temperature_min_12","temperature_min_12","WorldClim_2.1_MRI-ESM2-0_ssp245_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Dec","min T Dec","december","degrees Celsius","*degree*C*", +"temperature_max_01","temperature_max_01","WorldClim_2.1_MRI-ESM2-0_ssp245_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jan","max T Jan","january","degrees Celsius","*degree*C*", +"temperature_max_02","temperature_max_02","WorldClim_2.1_MRI-ESM2-0_ssp245_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Feb","max T Feb","february","degrees Celsius","*degree*C*", +"temperature_max_03","temperature_max_03","WorldClim_2.1_MRI-ESM2-0_ssp245_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Mar","max T Mar","march","degrees Celsius","*degree*C*", +"temperature_max_04","temperature_max_04","WorldClim_2.1_MRI-ESM2-0_ssp245_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Apr","max T Apr","april","degrees Celsius","*degree*C*", +"temperature_max_05","temperature_max_05","WorldClim_2.1_MRI-ESM2-0_ssp245_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature May","max T May","may","degrees Celsius","*degree*C*", +"temperature_max_06","temperature_max_06","WorldClim_2.1_MRI-ESM2-0_ssp245_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jun","max T Jun","june","degrees Celsius","*degree*C*", +"temperature_max_07","temperature_max_07","WorldClim_2.1_MRI-ESM2-0_ssp245_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jul","max T Jul","july","degrees Celsius","*degree*C*", +"temperature_max_08","temperature_max_08","WorldClim_2.1_MRI-ESM2-0_ssp245_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Aug","max T Aug","august","degrees Celsius","*degree*C*", +"temperature_max_09","temperature_max_09","WorldClim_2.1_MRI-ESM2-0_ssp245_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Sep","max T Sep","september","degrees Celsius","*degree*C*", +"temperature_max_10","temperature_max_10","WorldClim_2.1_MRI-ESM2-0_ssp245_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Oct","max T Oct","october","degrees Celsius","*degree*C*", +"temperature_max_11","temperature_max_11","WorldClim_2.1_MRI-ESM2-0_ssp245_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Nov","max T Nov","november","degrees Celsius","*degree*C*", +"temperature_max_12","temperature_max_12","WorldClim_2.1_MRI-ESM2-0_ssp245_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Dec","max T Dec","december","degrees Celsius","*degree*C*", +"bio01","bio01","WorldClim_2.1_MRI-ESM2-0_ssp370_10m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual mean temperature","ann. mean T","year","degrees Celsius","*degree*C*", +"bio02","bio02","WorldClim_2.1_MRI-ESM2-0_ssp370_10m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean diurnal range","diurn. range","year","degrees Celsius","*degree*C*", +"bio03","bio03","WorldClim_2.1_MRI-ESM2-0_ssp370_10m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","isothermality","isothermality","year","","", +"bio04","bio04","WorldClim_2.1_MRI-ESM2-0_ssp370_10m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature seasonality","T season.","year","degrees Celsius","*degree*C*", +"bio05","bio05","WorldClim_2.1_MRI-ESM2-0_ssp370_10m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature of warmest month","max. T of warmest mo.","year","degrees Celsius","*degree*C*", +"bio06","bio06","WorldClim_2.1_MRI-ESM2-0_ssp370_10m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature of coldest month","min. T of coldest mo.","year","degrees Celsius","*degree*C*", +"bio07","bio07","WorldClim_2.1_MRI-ESM2-0_ssp370_10m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature annual range (bio05-bio06)","T ann. Range","year","degrees Celsius","*degree*C*", +"bio08","bio08","WorldClim_2.1_MRI-ESM2-0_ssp370_10m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of wettest quarter","mean T of wettest qtr","year","degrees Celsius","*degree*C*", +"bio09","bio09","WorldClim_2.1_MRI-ESM2-0_ssp370_10m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of driest quarter","mean T of driest qtr","year","degrees Celsius","*degree*C*", +"bio10","bio10","WorldClim_2.1_MRI-ESM2-0_ssp370_10m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of warmest quarter","mean T of warmest qtr","year","degrees Celsius","*degree*C*", +"bio11","bio11","WorldClim_2.1_MRI-ESM2-0_ssp370_10m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of coldest quarter","mean T of coldest qtr","year","degrees Celsius","*degree*C*", +"bio12","bio12","WorldClim_2.1_MRI-ESM2-0_ssp370_10m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual precipitation","ann. P","year","mm per year","*mm~yr^-1*", +"bio13","bio13","WorldClim_2.1_MRI-ESM2-0_ssp370_10m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest month","P of wettest mo.","year","mm per month","*mm~mo^-1*", +"bio14","bio14","WorldClim_2.1_MRI-ESM2-0_ssp370_10m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest month","P of driest mo.","year","mm per month","*mm~mo^-1*", +"bio15","bio15","WorldClim_2.1_MRI-ESM2-0_ssp370_10m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation seasonality (coeff var)","P season.","year","","", +"bio16","bio16","WorldClim_2.1_MRI-ESM2-0_ssp370_10m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest quarter","P of wettest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio17","bio17","WorldClim_2.1_MRI-ESM2-0_ssp370_10m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest quarter","P of driest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio18","bio18","WorldClim_2.1_MRI-ESM2-0_ssp370_10m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of warmest quarter","P of warmest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio19","bio19","WorldClim_2.1_MRI-ESM2-0_ssp370_10m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of coldest quarter","P of coldest qtr","year","mm per quarter","*mm~qtr^-1*", +"precipitation_01","precipitation_01","WorldClim_2.1_MRI-ESM2-0_ssp370_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jan","P Jan","january","mm per month","*mm~mo^-1*", +"precipitation_02","precipitation_02","WorldClim_2.1_MRI-ESM2-0_ssp370_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Feb","P Feb","february","mm per month","*mm~mo^-1*", +"precipitation_03","precipitation_03","WorldClim_2.1_MRI-ESM2-0_ssp370_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Mar","P Mar","march","mm per month","*mm~mo^-1*", +"precipitation_04","precipitation_04","WorldClim_2.1_MRI-ESM2-0_ssp370_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Apr","P Apr","april","mm per month","*mm~mo^-1*", +"precipitation_05","precipitation_05","WorldClim_2.1_MRI-ESM2-0_ssp370_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation May","P May","may","mm per month","*mm~mo^-1*", +"precipitation_06","precipitation_06","WorldClim_2.1_MRI-ESM2-0_ssp370_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jun","P Jun","june","mm per month","*mm~mo^-1*", +"precipitation_07","precipitation_07","WorldClim_2.1_MRI-ESM2-0_ssp370_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jul","P Jul","july","mm per month","*mm~mo^-1*", +"precipitation_08","precipitation_08","WorldClim_2.1_MRI-ESM2-0_ssp370_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Aug","P Aug","august","mm per month","*mm~mo^-1*", +"precipitation_09","precipitation_09","WorldClim_2.1_MRI-ESM2-0_ssp370_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Sep","P Sep","september","mm per month","*mm~mo^-1*", +"precipitation_10","precipitation_10","WorldClim_2.1_MRI-ESM2-0_ssp370_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Oct","P Oct","october","mm per month","*mm~mo^-1*", +"precipitation_11","precipitation_11","WorldClim_2.1_MRI-ESM2-0_ssp370_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Nov","P Nov","november","mm per month","*mm~mo^-1*", +"precipitation_12","precipitation_12","WorldClim_2.1_MRI-ESM2-0_ssp370_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Dec","P Dec","december","mm per month","*mm~mo^-1*", +"temperature_min_01","temperature_min_01","WorldClim_2.1_MRI-ESM2-0_ssp370_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jan","min T Jan","january","degrees Celsius","*degree*C*", +"temperature_min_02","temperature_min_02","WorldClim_2.1_MRI-ESM2-0_ssp370_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Feb","min T Feb","february","degrees Celsius","*degree*C*", +"temperature_min_03","temperature_min_03","WorldClim_2.1_MRI-ESM2-0_ssp370_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Mar","min T Mar","march","degrees Celsius","*degree*C*", +"temperature_min_04","temperature_min_04","WorldClim_2.1_MRI-ESM2-0_ssp370_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Apr","min T Apr","april","degrees Celsius","*degree*C*", +"temperature_min_05","temperature_min_05","WorldClim_2.1_MRI-ESM2-0_ssp370_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature May","min T May","may","degrees Celsius","*degree*C*", +"temperature_min_06","temperature_min_06","WorldClim_2.1_MRI-ESM2-0_ssp370_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jun","min T Jun","june","degrees Celsius","*degree*C*", +"temperature_min_07","temperature_min_07","WorldClim_2.1_MRI-ESM2-0_ssp370_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jul","min T Jul","july","degrees Celsius","*degree*C*", +"temperature_min_08","temperature_min_08","WorldClim_2.1_MRI-ESM2-0_ssp370_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Aug","min T Aug","august","degrees Celsius","*degree*C*", +"temperature_min_09","temperature_min_09","WorldClim_2.1_MRI-ESM2-0_ssp370_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Sep","min T Sep","september","degrees Celsius","*degree*C*", +"temperature_min_10","temperature_min_10","WorldClim_2.1_MRI-ESM2-0_ssp370_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Oct","min T Oct","october","degrees Celsius","*degree*C*", +"temperature_min_11","temperature_min_11","WorldClim_2.1_MRI-ESM2-0_ssp370_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Nov","min T Nov","november","degrees Celsius","*degree*C*", +"temperature_min_12","temperature_min_12","WorldClim_2.1_MRI-ESM2-0_ssp370_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Dec","min T Dec","december","degrees Celsius","*degree*C*", +"temperature_max_01","temperature_max_01","WorldClim_2.1_MRI-ESM2-0_ssp370_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jan","max T Jan","january","degrees Celsius","*degree*C*", +"temperature_max_02","temperature_max_02","WorldClim_2.1_MRI-ESM2-0_ssp370_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Feb","max T Feb","february","degrees Celsius","*degree*C*", +"temperature_max_03","temperature_max_03","WorldClim_2.1_MRI-ESM2-0_ssp370_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Mar","max T Mar","march","degrees Celsius","*degree*C*", +"temperature_max_04","temperature_max_04","WorldClim_2.1_MRI-ESM2-0_ssp370_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Apr","max T Apr","april","degrees Celsius","*degree*C*", +"temperature_max_05","temperature_max_05","WorldClim_2.1_MRI-ESM2-0_ssp370_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature May","max T May","may","degrees Celsius","*degree*C*", +"temperature_max_06","temperature_max_06","WorldClim_2.1_MRI-ESM2-0_ssp370_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jun","max T Jun","june","degrees Celsius","*degree*C*", +"temperature_max_07","temperature_max_07","WorldClim_2.1_MRI-ESM2-0_ssp370_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jul","max T Jul","july","degrees Celsius","*degree*C*", +"temperature_max_08","temperature_max_08","WorldClim_2.1_MRI-ESM2-0_ssp370_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Aug","max T Aug","august","degrees Celsius","*degree*C*", +"temperature_max_09","temperature_max_09","WorldClim_2.1_MRI-ESM2-0_ssp370_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Sep","max T Sep","september","degrees Celsius","*degree*C*", +"temperature_max_10","temperature_max_10","WorldClim_2.1_MRI-ESM2-0_ssp370_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Oct","max T Oct","october","degrees Celsius","*degree*C*", +"temperature_max_11","temperature_max_11","WorldClim_2.1_MRI-ESM2-0_ssp370_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Nov","max T Nov","november","degrees Celsius","*degree*C*", +"temperature_max_12","temperature_max_12","WorldClim_2.1_MRI-ESM2-0_ssp370_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Dec","max T Dec","december","degrees Celsius","*degree*C*", +"bio01","bio01","WorldClim_2.1_MRI-ESM2-0_ssp370_5m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual mean temperature","ann. mean T","year","degrees Celsius","*degree*C*", +"bio02","bio02","WorldClim_2.1_MRI-ESM2-0_ssp370_5m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean diurnal range","diurn. range","year","degrees Celsius","*degree*C*", +"bio03","bio03","WorldClim_2.1_MRI-ESM2-0_ssp370_5m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","isothermality","isothermality","year","","", +"bio04","bio04","WorldClim_2.1_MRI-ESM2-0_ssp370_5m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature seasonality","T season.","year","degrees Celsius","*degree*C*", +"bio05","bio05","WorldClim_2.1_MRI-ESM2-0_ssp370_5m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature of warmest month","max. T of warmest mo.","year","degrees Celsius","*degree*C*", +"bio06","bio06","WorldClim_2.1_MRI-ESM2-0_ssp370_5m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature of coldest month","min. T of coldest mo.","year","degrees Celsius","*degree*C*", +"bio07","bio07","WorldClim_2.1_MRI-ESM2-0_ssp370_5m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature annual range (bio05-bio06)","T ann. Range","year","degrees Celsius","*degree*C*", +"bio08","bio08","WorldClim_2.1_MRI-ESM2-0_ssp370_5m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of wettest quarter","mean T of wettest qtr","year","degrees Celsius","*degree*C*", +"bio09","bio09","WorldClim_2.1_MRI-ESM2-0_ssp370_5m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of driest quarter","mean T of driest qtr","year","degrees Celsius","*degree*C*", +"bio10","bio10","WorldClim_2.1_MRI-ESM2-0_ssp370_5m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of warmest quarter","mean T of warmest qtr","year","degrees Celsius","*degree*C*", +"bio11","bio11","WorldClim_2.1_MRI-ESM2-0_ssp370_5m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of coldest quarter","mean T of coldest qtr","year","degrees Celsius","*degree*C*", +"bio12","bio12","WorldClim_2.1_MRI-ESM2-0_ssp370_5m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual precipitation","ann. P","year","mm per year","*mm~yr^-1*", +"bio13","bio13","WorldClim_2.1_MRI-ESM2-0_ssp370_5m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest month","P of wettest mo.","year","mm per month","*mm~mo^-1*", +"bio14","bio14","WorldClim_2.1_MRI-ESM2-0_ssp370_5m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest month","P of driest mo.","year","mm per month","*mm~mo^-1*", +"bio15","bio15","WorldClim_2.1_MRI-ESM2-0_ssp370_5m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation seasonality (coeff var)","P season.","year","","", +"bio16","bio16","WorldClim_2.1_MRI-ESM2-0_ssp370_5m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest quarter","P of wettest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio17","bio17","WorldClim_2.1_MRI-ESM2-0_ssp370_5m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest quarter","P of driest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio18","bio18","WorldClim_2.1_MRI-ESM2-0_ssp370_5m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of warmest quarter","P of warmest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio19","bio19","WorldClim_2.1_MRI-ESM2-0_ssp370_5m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of coldest quarter","P of coldest qtr","year","mm per quarter","*mm~qtr^-1*", +"precipitation_01","precipitation_01","WorldClim_2.1_MRI-ESM2-0_ssp370_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jan","P Jan","january","mm per month","*mm~mo^-1*", +"precipitation_02","precipitation_02","WorldClim_2.1_MRI-ESM2-0_ssp370_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Feb","P Feb","february","mm per month","*mm~mo^-1*", +"precipitation_03","precipitation_03","WorldClim_2.1_MRI-ESM2-0_ssp370_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Mar","P Mar","march","mm per month","*mm~mo^-1*", +"precipitation_04","precipitation_04","WorldClim_2.1_MRI-ESM2-0_ssp370_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Apr","P Apr","april","mm per month","*mm~mo^-1*", +"precipitation_05","precipitation_05","WorldClim_2.1_MRI-ESM2-0_ssp370_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation May","P May","may","mm per month","*mm~mo^-1*", +"precipitation_06","precipitation_06","WorldClim_2.1_MRI-ESM2-0_ssp370_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jun","P Jun","june","mm per month","*mm~mo^-1*", +"precipitation_07","precipitation_07","WorldClim_2.1_MRI-ESM2-0_ssp370_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jul","P Jul","july","mm per month","*mm~mo^-1*", +"precipitation_08","precipitation_08","WorldClim_2.1_MRI-ESM2-0_ssp370_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Aug","P Aug","august","mm per month","*mm~mo^-1*", +"precipitation_09","precipitation_09","WorldClim_2.1_MRI-ESM2-0_ssp370_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Sep","P Sep","september","mm per month","*mm~mo^-1*", +"precipitation_10","precipitation_10","WorldClim_2.1_MRI-ESM2-0_ssp370_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Oct","P Oct","october","mm per month","*mm~mo^-1*", +"precipitation_11","precipitation_11","WorldClim_2.1_MRI-ESM2-0_ssp370_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Nov","P Nov","november","mm per month","*mm~mo^-1*", +"precipitation_12","precipitation_12","WorldClim_2.1_MRI-ESM2-0_ssp370_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Dec","P Dec","december","mm per month","*mm~mo^-1*", +"temperature_min_01","temperature_min_01","WorldClim_2.1_MRI-ESM2-0_ssp370_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jan","min T Jan","january","degrees Celsius","*degree*C*", +"temperature_min_02","temperature_min_02","WorldClim_2.1_MRI-ESM2-0_ssp370_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Feb","min T Feb","february","degrees Celsius","*degree*C*", +"temperature_min_03","temperature_min_03","WorldClim_2.1_MRI-ESM2-0_ssp370_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Mar","min T Mar","march","degrees Celsius","*degree*C*", +"temperature_min_04","temperature_min_04","WorldClim_2.1_MRI-ESM2-0_ssp370_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Apr","min T Apr","april","degrees Celsius","*degree*C*", +"temperature_min_05","temperature_min_05","WorldClim_2.1_MRI-ESM2-0_ssp370_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature May","min T May","may","degrees Celsius","*degree*C*", +"temperature_min_06","temperature_min_06","WorldClim_2.1_MRI-ESM2-0_ssp370_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jun","min T Jun","june","degrees Celsius","*degree*C*", +"temperature_min_07","temperature_min_07","WorldClim_2.1_MRI-ESM2-0_ssp370_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jul","min T Jul","july","degrees Celsius","*degree*C*", +"temperature_min_08","temperature_min_08","WorldClim_2.1_MRI-ESM2-0_ssp370_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Aug","min T Aug","august","degrees Celsius","*degree*C*", +"temperature_min_09","temperature_min_09","WorldClim_2.1_MRI-ESM2-0_ssp370_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Sep","min T Sep","september","degrees Celsius","*degree*C*", +"temperature_min_10","temperature_min_10","WorldClim_2.1_MRI-ESM2-0_ssp370_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Oct","min T Oct","october","degrees Celsius","*degree*C*", +"temperature_min_11","temperature_min_11","WorldClim_2.1_MRI-ESM2-0_ssp370_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Nov","min T Nov","november","degrees Celsius","*degree*C*", +"temperature_min_12","temperature_min_12","WorldClim_2.1_MRI-ESM2-0_ssp370_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Dec","min T Dec","december","degrees Celsius","*degree*C*", +"temperature_max_01","temperature_max_01","WorldClim_2.1_MRI-ESM2-0_ssp370_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jan","max T Jan","january","degrees Celsius","*degree*C*", +"temperature_max_02","temperature_max_02","WorldClim_2.1_MRI-ESM2-0_ssp370_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Feb","max T Feb","february","degrees Celsius","*degree*C*", +"temperature_max_03","temperature_max_03","WorldClim_2.1_MRI-ESM2-0_ssp370_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Mar","max T Mar","march","degrees Celsius","*degree*C*", +"temperature_max_04","temperature_max_04","WorldClim_2.1_MRI-ESM2-0_ssp370_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Apr","max T Apr","april","degrees Celsius","*degree*C*", +"temperature_max_05","temperature_max_05","WorldClim_2.1_MRI-ESM2-0_ssp370_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature May","max T May","may","degrees Celsius","*degree*C*", +"temperature_max_06","temperature_max_06","WorldClim_2.1_MRI-ESM2-0_ssp370_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jun","max T Jun","june","degrees Celsius","*degree*C*", +"temperature_max_07","temperature_max_07","WorldClim_2.1_MRI-ESM2-0_ssp370_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jul","max T Jul","july","degrees Celsius","*degree*C*", +"temperature_max_08","temperature_max_08","WorldClim_2.1_MRI-ESM2-0_ssp370_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Aug","max T Aug","august","degrees Celsius","*degree*C*", +"temperature_max_09","temperature_max_09","WorldClim_2.1_MRI-ESM2-0_ssp370_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Sep","max T Sep","september","degrees Celsius","*degree*C*", +"temperature_max_10","temperature_max_10","WorldClim_2.1_MRI-ESM2-0_ssp370_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Oct","max T Oct","october","degrees Celsius","*degree*C*", +"temperature_max_11","temperature_max_11","WorldClim_2.1_MRI-ESM2-0_ssp370_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Nov","max T Nov","november","degrees Celsius","*degree*C*", +"temperature_max_12","temperature_max_12","WorldClim_2.1_MRI-ESM2-0_ssp370_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Dec","max T Dec","december","degrees Celsius","*degree*C*", +"bio01","bio01","WorldClim_2.1_MRI-ESM2-0_ssp585_10m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual mean temperature","ann. mean T","year","degrees Celsius","*degree*C*", +"bio02","bio02","WorldClim_2.1_MRI-ESM2-0_ssp585_10m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean diurnal range","diurn. range","year","degrees Celsius","*degree*C*", +"bio03","bio03","WorldClim_2.1_MRI-ESM2-0_ssp585_10m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","isothermality","isothermality","year","","", +"bio04","bio04","WorldClim_2.1_MRI-ESM2-0_ssp585_10m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature seasonality","T season.","year","degrees Celsius","*degree*C*", +"bio05","bio05","WorldClim_2.1_MRI-ESM2-0_ssp585_10m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature of warmest month","max. T of warmest mo.","year","degrees Celsius","*degree*C*", +"bio06","bio06","WorldClim_2.1_MRI-ESM2-0_ssp585_10m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature of coldest month","min. T of coldest mo.","year","degrees Celsius","*degree*C*", +"bio07","bio07","WorldClim_2.1_MRI-ESM2-0_ssp585_10m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature annual range (bio05-bio06)","T ann. Range","year","degrees Celsius","*degree*C*", +"bio08","bio08","WorldClim_2.1_MRI-ESM2-0_ssp585_10m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of wettest quarter","mean T of wettest qtr","year","degrees Celsius","*degree*C*", +"bio09","bio09","WorldClim_2.1_MRI-ESM2-0_ssp585_10m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of driest quarter","mean T of driest qtr","year","degrees Celsius","*degree*C*", +"bio10","bio10","WorldClim_2.1_MRI-ESM2-0_ssp585_10m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of warmest quarter","mean T of warmest qtr","year","degrees Celsius","*degree*C*", +"bio11","bio11","WorldClim_2.1_MRI-ESM2-0_ssp585_10m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of coldest quarter","mean T of coldest qtr","year","degrees Celsius","*degree*C*", +"bio12","bio12","WorldClim_2.1_MRI-ESM2-0_ssp585_10m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual precipitation","ann. P","year","mm per year","*mm~yr^-1*", +"bio13","bio13","WorldClim_2.1_MRI-ESM2-0_ssp585_10m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest month","P of wettest mo.","year","mm per month","*mm~mo^-1*", +"bio14","bio14","WorldClim_2.1_MRI-ESM2-0_ssp585_10m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest month","P of driest mo.","year","mm per month","*mm~mo^-1*", +"bio15","bio15","WorldClim_2.1_MRI-ESM2-0_ssp585_10m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation seasonality (coeff var)","P season.","year","","", +"bio16","bio16","WorldClim_2.1_MRI-ESM2-0_ssp585_10m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest quarter","P of wettest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio17","bio17","WorldClim_2.1_MRI-ESM2-0_ssp585_10m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest quarter","P of driest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio18","bio18","WorldClim_2.1_MRI-ESM2-0_ssp585_10m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of warmest quarter","P of warmest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio19","bio19","WorldClim_2.1_MRI-ESM2-0_ssp585_10m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of coldest quarter","P of coldest qtr","year","mm per quarter","*mm~qtr^-1*", +"precipitation_01","precipitation_01","WorldClim_2.1_MRI-ESM2-0_ssp585_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jan","P Jan","january","mm per month","*mm~mo^-1*", +"precipitation_02","precipitation_02","WorldClim_2.1_MRI-ESM2-0_ssp585_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Feb","P Feb","february","mm per month","*mm~mo^-1*", +"precipitation_03","precipitation_03","WorldClim_2.1_MRI-ESM2-0_ssp585_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Mar","P Mar","march","mm per month","*mm~mo^-1*", +"precipitation_04","precipitation_04","WorldClim_2.1_MRI-ESM2-0_ssp585_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Apr","P Apr","april","mm per month","*mm~mo^-1*", +"precipitation_05","precipitation_05","WorldClim_2.1_MRI-ESM2-0_ssp585_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation May","P May","may","mm per month","*mm~mo^-1*", +"precipitation_06","precipitation_06","WorldClim_2.1_MRI-ESM2-0_ssp585_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jun","P Jun","june","mm per month","*mm~mo^-1*", +"precipitation_07","precipitation_07","WorldClim_2.1_MRI-ESM2-0_ssp585_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jul","P Jul","july","mm per month","*mm~mo^-1*", +"precipitation_08","precipitation_08","WorldClim_2.1_MRI-ESM2-0_ssp585_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Aug","P Aug","august","mm per month","*mm~mo^-1*", +"precipitation_09","precipitation_09","WorldClim_2.1_MRI-ESM2-0_ssp585_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Sep","P Sep","september","mm per month","*mm~mo^-1*", +"precipitation_10","precipitation_10","WorldClim_2.1_MRI-ESM2-0_ssp585_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Oct","P Oct","october","mm per month","*mm~mo^-1*", +"precipitation_11","precipitation_11","WorldClim_2.1_MRI-ESM2-0_ssp585_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Nov","P Nov","november","mm per month","*mm~mo^-1*", +"precipitation_12","precipitation_12","WorldClim_2.1_MRI-ESM2-0_ssp585_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Dec","P Dec","december","mm per month","*mm~mo^-1*", +"temperature_min_01","temperature_min_01","WorldClim_2.1_MRI-ESM2-0_ssp585_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jan","min T Jan","january","degrees Celsius","*degree*C*", +"temperature_min_02","temperature_min_02","WorldClim_2.1_MRI-ESM2-0_ssp585_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Feb","min T Feb","february","degrees Celsius","*degree*C*", +"temperature_min_03","temperature_min_03","WorldClim_2.1_MRI-ESM2-0_ssp585_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Mar","min T Mar","march","degrees Celsius","*degree*C*", +"temperature_min_04","temperature_min_04","WorldClim_2.1_MRI-ESM2-0_ssp585_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Apr","min T Apr","april","degrees Celsius","*degree*C*", +"temperature_min_05","temperature_min_05","WorldClim_2.1_MRI-ESM2-0_ssp585_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature May","min T May","may","degrees Celsius","*degree*C*", +"temperature_min_06","temperature_min_06","WorldClim_2.1_MRI-ESM2-0_ssp585_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jun","min T Jun","june","degrees Celsius","*degree*C*", +"temperature_min_07","temperature_min_07","WorldClim_2.1_MRI-ESM2-0_ssp585_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jul","min T Jul","july","degrees Celsius","*degree*C*", +"temperature_min_08","temperature_min_08","WorldClim_2.1_MRI-ESM2-0_ssp585_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Aug","min T Aug","august","degrees Celsius","*degree*C*", +"temperature_min_09","temperature_min_09","WorldClim_2.1_MRI-ESM2-0_ssp585_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Sep","min T Sep","september","degrees Celsius","*degree*C*", +"temperature_min_10","temperature_min_10","WorldClim_2.1_MRI-ESM2-0_ssp585_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Oct","min T Oct","october","degrees Celsius","*degree*C*", +"temperature_min_11","temperature_min_11","WorldClim_2.1_MRI-ESM2-0_ssp585_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Nov","min T Nov","november","degrees Celsius","*degree*C*", +"temperature_min_12","temperature_min_12","WorldClim_2.1_MRI-ESM2-0_ssp585_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Dec","min T Dec","december","degrees Celsius","*degree*C*", +"temperature_max_01","temperature_max_01","WorldClim_2.1_MRI-ESM2-0_ssp585_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jan","max T Jan","january","degrees Celsius","*degree*C*", +"temperature_max_02","temperature_max_02","WorldClim_2.1_MRI-ESM2-0_ssp585_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Feb","max T Feb","february","degrees Celsius","*degree*C*", +"temperature_max_03","temperature_max_03","WorldClim_2.1_MRI-ESM2-0_ssp585_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Mar","max T Mar","march","degrees Celsius","*degree*C*", +"temperature_max_04","temperature_max_04","WorldClim_2.1_MRI-ESM2-0_ssp585_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Apr","max T Apr","april","degrees Celsius","*degree*C*", +"temperature_max_05","temperature_max_05","WorldClim_2.1_MRI-ESM2-0_ssp585_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature May","max T May","may","degrees Celsius","*degree*C*", +"temperature_max_06","temperature_max_06","WorldClim_2.1_MRI-ESM2-0_ssp585_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jun","max T Jun","june","degrees Celsius","*degree*C*", +"temperature_max_07","temperature_max_07","WorldClim_2.1_MRI-ESM2-0_ssp585_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jul","max T Jul","july","degrees Celsius","*degree*C*", +"temperature_max_08","temperature_max_08","WorldClim_2.1_MRI-ESM2-0_ssp585_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Aug","max T Aug","august","degrees Celsius","*degree*C*", +"temperature_max_09","temperature_max_09","WorldClim_2.1_MRI-ESM2-0_ssp585_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Sep","max T Sep","september","degrees Celsius","*degree*C*", +"temperature_max_10","temperature_max_10","WorldClim_2.1_MRI-ESM2-0_ssp585_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Oct","max T Oct","october","degrees Celsius","*degree*C*", +"temperature_max_11","temperature_max_11","WorldClim_2.1_MRI-ESM2-0_ssp585_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Nov","max T Nov","november","degrees Celsius","*degree*C*", +"temperature_max_12","temperature_max_12","WorldClim_2.1_MRI-ESM2-0_ssp585_10m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Dec","max T Dec","december","degrees Celsius","*degree*C*", +"bio01","bio01","WorldClim_2.1_MRI-ESM2-0_ssp585_5m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual mean temperature","ann. mean T","year","degrees Celsius","*degree*C*", +"bio02","bio02","WorldClim_2.1_MRI-ESM2-0_ssp585_5m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean diurnal range","diurn. range","year","degrees Celsius","*degree*C*", +"bio03","bio03","WorldClim_2.1_MRI-ESM2-0_ssp585_5m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","isothermality","isothermality","year","","", +"bio04","bio04","WorldClim_2.1_MRI-ESM2-0_ssp585_5m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature seasonality","T season.","year","degrees Celsius","*degree*C*", +"bio05","bio05","WorldClim_2.1_MRI-ESM2-0_ssp585_5m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature of warmest month","max. T of warmest mo.","year","degrees Celsius","*degree*C*", +"bio06","bio06","WorldClim_2.1_MRI-ESM2-0_ssp585_5m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature of coldest month","min. T of coldest mo.","year","degrees Celsius","*degree*C*", +"bio07","bio07","WorldClim_2.1_MRI-ESM2-0_ssp585_5m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature annual range (bio05-bio06)","T ann. Range","year","degrees Celsius","*degree*C*", +"bio08","bio08","WorldClim_2.1_MRI-ESM2-0_ssp585_5m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of wettest quarter","mean T of wettest qtr","year","degrees Celsius","*degree*C*", +"bio09","bio09","WorldClim_2.1_MRI-ESM2-0_ssp585_5m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of driest quarter","mean T of driest qtr","year","degrees Celsius","*degree*C*", +"bio10","bio10","WorldClim_2.1_MRI-ESM2-0_ssp585_5m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of warmest quarter","mean T of warmest qtr","year","degrees Celsius","*degree*C*", +"bio11","bio11","WorldClim_2.1_MRI-ESM2-0_ssp585_5m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of coldest quarter","mean T of coldest qtr","year","degrees Celsius","*degree*C*", +"bio12","bio12","WorldClim_2.1_MRI-ESM2-0_ssp585_5m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual precipitation","ann. P","year","mm per year","*mm~yr^-1*", +"bio13","bio13","WorldClim_2.1_MRI-ESM2-0_ssp585_5m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest month","P of wettest mo.","year","mm per month","*mm~mo^-1*", +"bio14","bio14","WorldClim_2.1_MRI-ESM2-0_ssp585_5m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest month","P of driest mo.","year","mm per month","*mm~mo^-1*", +"bio15","bio15","WorldClim_2.1_MRI-ESM2-0_ssp585_5m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation seasonality (coeff var)","P season.","year","","", +"bio16","bio16","WorldClim_2.1_MRI-ESM2-0_ssp585_5m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest quarter","P of wettest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio17","bio17","WorldClim_2.1_MRI-ESM2-0_ssp585_5m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest quarter","P of driest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio18","bio18","WorldClim_2.1_MRI-ESM2-0_ssp585_5m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of warmest quarter","P of warmest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio19","bio19","WorldClim_2.1_MRI-ESM2-0_ssp585_5m",FALSE,"WorldClim_2.1_MRI-ESM2-0_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of coldest quarter","P of coldest qtr","year","mm per quarter","*mm~qtr^-1*", +"precipitation_01","precipitation_01","WorldClim_2.1_MRI-ESM2-0_ssp585_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jan","P Jan","january","mm per month","*mm~mo^-1*", +"precipitation_02","precipitation_02","WorldClim_2.1_MRI-ESM2-0_ssp585_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Feb","P Feb","february","mm per month","*mm~mo^-1*", +"precipitation_03","precipitation_03","WorldClim_2.1_MRI-ESM2-0_ssp585_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Mar","P Mar","march","mm per month","*mm~mo^-1*", +"precipitation_04","precipitation_04","WorldClim_2.1_MRI-ESM2-0_ssp585_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Apr","P Apr","april","mm per month","*mm~mo^-1*", +"precipitation_05","precipitation_05","WorldClim_2.1_MRI-ESM2-0_ssp585_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation May","P May","may","mm per month","*mm~mo^-1*", +"precipitation_06","precipitation_06","WorldClim_2.1_MRI-ESM2-0_ssp585_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jun","P Jun","june","mm per month","*mm~mo^-1*", +"precipitation_07","precipitation_07","WorldClim_2.1_MRI-ESM2-0_ssp585_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jul","P Jul","july","mm per month","*mm~mo^-1*", +"precipitation_08","precipitation_08","WorldClim_2.1_MRI-ESM2-0_ssp585_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Aug","P Aug","august","mm per month","*mm~mo^-1*", +"precipitation_09","precipitation_09","WorldClim_2.1_MRI-ESM2-0_ssp585_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Sep","P Sep","september","mm per month","*mm~mo^-1*", +"precipitation_10","precipitation_10","WorldClim_2.1_MRI-ESM2-0_ssp585_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Oct","P Oct","october","mm per month","*mm~mo^-1*", +"precipitation_11","precipitation_11","WorldClim_2.1_MRI-ESM2-0_ssp585_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Nov","P Nov","november","mm per month","*mm~mo^-1*", +"precipitation_12","precipitation_12","WorldClim_2.1_MRI-ESM2-0_ssp585_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Dec","P Dec","december","mm per month","*mm~mo^-1*", +"temperature_min_01","temperature_min_01","WorldClim_2.1_MRI-ESM2-0_ssp585_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jan","min T Jan","january","degrees Celsius","*degree*C*", +"temperature_min_02","temperature_min_02","WorldClim_2.1_MRI-ESM2-0_ssp585_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Feb","min T Feb","february","degrees Celsius","*degree*C*", +"temperature_min_03","temperature_min_03","WorldClim_2.1_MRI-ESM2-0_ssp585_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Mar","min T Mar","march","degrees Celsius","*degree*C*", +"temperature_min_04","temperature_min_04","WorldClim_2.1_MRI-ESM2-0_ssp585_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Apr","min T Apr","april","degrees Celsius","*degree*C*", +"temperature_min_05","temperature_min_05","WorldClim_2.1_MRI-ESM2-0_ssp585_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature May","min T May","may","degrees Celsius","*degree*C*", +"temperature_min_06","temperature_min_06","WorldClim_2.1_MRI-ESM2-0_ssp585_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jun","min T Jun","june","degrees Celsius","*degree*C*", +"temperature_min_07","temperature_min_07","WorldClim_2.1_MRI-ESM2-0_ssp585_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jul","min T Jul","july","degrees Celsius","*degree*C*", +"temperature_min_08","temperature_min_08","WorldClim_2.1_MRI-ESM2-0_ssp585_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Aug","min T Aug","august","degrees Celsius","*degree*C*", +"temperature_min_09","temperature_min_09","WorldClim_2.1_MRI-ESM2-0_ssp585_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Sep","min T Sep","september","degrees Celsius","*degree*C*", +"temperature_min_10","temperature_min_10","WorldClim_2.1_MRI-ESM2-0_ssp585_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Oct","min T Oct","october","degrees Celsius","*degree*C*", +"temperature_min_11","temperature_min_11","WorldClim_2.1_MRI-ESM2-0_ssp585_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Nov","min T Nov","november","degrees Celsius","*degree*C*", +"temperature_min_12","temperature_min_12","WorldClim_2.1_MRI-ESM2-0_ssp585_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Dec","min T Dec","december","degrees Celsius","*degree*C*", +"temperature_max_01","temperature_max_01","WorldClim_2.1_MRI-ESM2-0_ssp585_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jan","max T Jan","january","degrees Celsius","*degree*C*", +"temperature_max_02","temperature_max_02","WorldClim_2.1_MRI-ESM2-0_ssp585_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Feb","max T Feb","february","degrees Celsius","*degree*C*", +"temperature_max_03","temperature_max_03","WorldClim_2.1_MRI-ESM2-0_ssp585_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Mar","max T Mar","march","degrees Celsius","*degree*C*", +"temperature_max_04","temperature_max_04","WorldClim_2.1_MRI-ESM2-0_ssp585_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Apr","max T Apr","april","degrees Celsius","*degree*C*", +"temperature_max_05","temperature_max_05","WorldClim_2.1_MRI-ESM2-0_ssp585_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature May","max T May","may","degrees Celsius","*degree*C*", +"temperature_max_06","temperature_max_06","WorldClim_2.1_MRI-ESM2-0_ssp585_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jun","max T Jun","june","degrees Celsius","*degree*C*", +"temperature_max_07","temperature_max_07","WorldClim_2.1_MRI-ESM2-0_ssp585_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jul","max T Jul","july","degrees Celsius","*degree*C*", +"temperature_max_08","temperature_max_08","WorldClim_2.1_MRI-ESM2-0_ssp585_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Aug","max T Aug","august","degrees Celsius","*degree*C*", +"temperature_max_09","temperature_max_09","WorldClim_2.1_MRI-ESM2-0_ssp585_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Sep","max T Sep","september","degrees Celsius","*degree*C*", +"temperature_max_10","temperature_max_10","WorldClim_2.1_MRI-ESM2-0_ssp585_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Oct","max T Oct","october","degrees Celsius","*degree*C*", +"temperature_max_11","temperature_max_11","WorldClim_2.1_MRI-ESM2-0_ssp585_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Nov","max T Nov","november","degrees Celsius","*degree*C*", +"temperature_max_12","temperature_max_12","WorldClim_2.1_MRI-ESM2-0_ssp585_5m",TRUE,"WorldClim_2.1_MRI-ESM2-0_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Dec","max T Dec","december","degrees Celsius","*degree*C*", +"bio01","bio01","WorldClim_2.1_UKESM1-0-LL_ssp126_10m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual mean temperature","ann. mean T","year","degrees Celsius","*degree*C*", +"bio02","bio02","WorldClim_2.1_UKESM1-0-LL_ssp126_10m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean diurnal range","diurn. range","year","degrees Celsius","*degree*C*", +"bio03","bio03","WorldClim_2.1_UKESM1-0-LL_ssp126_10m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","isothermality","isothermality","year","","", +"bio04","bio04","WorldClim_2.1_UKESM1-0-LL_ssp126_10m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature seasonality","T season.","year","degrees Celsius","*degree*C*", +"bio05","bio05","WorldClim_2.1_UKESM1-0-LL_ssp126_10m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature of warmest month","max. T of warmest mo.","year","degrees Celsius","*degree*C*", +"bio06","bio06","WorldClim_2.1_UKESM1-0-LL_ssp126_10m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature of coldest month","min. T of coldest mo.","year","degrees Celsius","*degree*C*", +"bio07","bio07","WorldClim_2.1_UKESM1-0-LL_ssp126_10m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature annual range (bio05-bio06)","T ann. Range","year","degrees Celsius","*degree*C*", +"bio08","bio08","WorldClim_2.1_UKESM1-0-LL_ssp126_10m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of wettest quarter","mean T of wettest qtr","year","degrees Celsius","*degree*C*", +"bio09","bio09","WorldClim_2.1_UKESM1-0-LL_ssp126_10m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of driest quarter","mean T of driest qtr","year","degrees Celsius","*degree*C*", +"bio10","bio10","WorldClim_2.1_UKESM1-0-LL_ssp126_10m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of warmest quarter","mean T of warmest qtr","year","degrees Celsius","*degree*C*", +"bio11","bio11","WorldClim_2.1_UKESM1-0-LL_ssp126_10m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of coldest quarter","mean T of coldest qtr","year","degrees Celsius","*degree*C*", +"bio12","bio12","WorldClim_2.1_UKESM1-0-LL_ssp126_10m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual precipitation","ann. P","year","mm per year","*mm~yr^-1*", +"bio13","bio13","WorldClim_2.1_UKESM1-0-LL_ssp126_10m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest month","P of wettest mo.","year","mm per month","*mm~mo^-1*", +"bio14","bio14","WorldClim_2.1_UKESM1-0-LL_ssp126_10m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest month","P of driest mo.","year","mm per month","*mm~mo^-1*", +"bio15","bio15","WorldClim_2.1_UKESM1-0-LL_ssp126_10m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation seasonality (coeff var)","P season.","year","","", +"bio16","bio16","WorldClim_2.1_UKESM1-0-LL_ssp126_10m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest quarter","P of wettest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio17","bio17","WorldClim_2.1_UKESM1-0-LL_ssp126_10m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest quarter","P of driest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio18","bio18","WorldClim_2.1_UKESM1-0-LL_ssp126_10m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of warmest quarter","P of warmest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio19","bio19","WorldClim_2.1_UKESM1-0-LL_ssp126_10m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp126_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of coldest quarter","P of coldest qtr","year","mm per quarter","*mm~qtr^-1*", +"precipitation_01","precipitation_01","WorldClim_2.1_UKESM1-0-LL_ssp126_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jan","P Jan","january","mm per month","*mm~mo^-1*", +"precipitation_02","precipitation_02","WorldClim_2.1_UKESM1-0-LL_ssp126_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Feb","P Feb","february","mm per month","*mm~mo^-1*", +"precipitation_03","precipitation_03","WorldClim_2.1_UKESM1-0-LL_ssp126_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Mar","P Mar","march","mm per month","*mm~mo^-1*", +"precipitation_04","precipitation_04","WorldClim_2.1_UKESM1-0-LL_ssp126_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Apr","P Apr","april","mm per month","*mm~mo^-1*", +"precipitation_05","precipitation_05","WorldClim_2.1_UKESM1-0-LL_ssp126_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation May","P May","may","mm per month","*mm~mo^-1*", +"precipitation_06","precipitation_06","WorldClim_2.1_UKESM1-0-LL_ssp126_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jun","P Jun","june","mm per month","*mm~mo^-1*", +"precipitation_07","precipitation_07","WorldClim_2.1_UKESM1-0-LL_ssp126_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jul","P Jul","july","mm per month","*mm~mo^-1*", +"precipitation_08","precipitation_08","WorldClim_2.1_UKESM1-0-LL_ssp126_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Aug","P Aug","august","mm per month","*mm~mo^-1*", +"precipitation_09","precipitation_09","WorldClim_2.1_UKESM1-0-LL_ssp126_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Sep","P Sep","september","mm per month","*mm~mo^-1*", +"precipitation_10","precipitation_10","WorldClim_2.1_UKESM1-0-LL_ssp126_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Oct","P Oct","october","mm per month","*mm~mo^-1*", +"precipitation_11","precipitation_11","WorldClim_2.1_UKESM1-0-LL_ssp126_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Nov","P Nov","november","mm per month","*mm~mo^-1*", +"precipitation_12","precipitation_12","WorldClim_2.1_UKESM1-0-LL_ssp126_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp126_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Dec","P Dec","december","mm per month","*mm~mo^-1*", +"temperature_min_01","temperature_min_01","WorldClim_2.1_UKESM1-0-LL_ssp126_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jan","min T Jan","january","degrees Celsius","*degree*C*", +"temperature_min_02","temperature_min_02","WorldClim_2.1_UKESM1-0-LL_ssp126_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Feb","min T Feb","february","degrees Celsius","*degree*C*", +"temperature_min_03","temperature_min_03","WorldClim_2.1_UKESM1-0-LL_ssp126_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Mar","min T Mar","march","degrees Celsius","*degree*C*", +"temperature_min_04","temperature_min_04","WorldClim_2.1_UKESM1-0-LL_ssp126_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Apr","min T Apr","april","degrees Celsius","*degree*C*", +"temperature_min_05","temperature_min_05","WorldClim_2.1_UKESM1-0-LL_ssp126_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature May","min T May","may","degrees Celsius","*degree*C*", +"temperature_min_06","temperature_min_06","WorldClim_2.1_UKESM1-0-LL_ssp126_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jun","min T Jun","june","degrees Celsius","*degree*C*", +"temperature_min_07","temperature_min_07","WorldClim_2.1_UKESM1-0-LL_ssp126_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jul","min T Jul","july","degrees Celsius","*degree*C*", +"temperature_min_08","temperature_min_08","WorldClim_2.1_UKESM1-0-LL_ssp126_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Aug","min T Aug","august","degrees Celsius","*degree*C*", +"temperature_min_09","temperature_min_09","WorldClim_2.1_UKESM1-0-LL_ssp126_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Sep","min T Sep","september","degrees Celsius","*degree*C*", +"temperature_min_10","temperature_min_10","WorldClim_2.1_UKESM1-0-LL_ssp126_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Oct","min T Oct","october","degrees Celsius","*degree*C*", +"temperature_min_11","temperature_min_11","WorldClim_2.1_UKESM1-0-LL_ssp126_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Nov","min T Nov","november","degrees Celsius","*degree*C*", +"temperature_min_12","temperature_min_12","WorldClim_2.1_UKESM1-0-LL_ssp126_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp126_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Dec","min T Dec","december","degrees Celsius","*degree*C*", +"temperature_max_01","temperature_max_01","WorldClim_2.1_UKESM1-0-LL_ssp126_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jan","max T Jan","january","degrees Celsius","*degree*C*", +"temperature_max_02","temperature_max_02","WorldClim_2.1_UKESM1-0-LL_ssp126_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Feb","max T Feb","february","degrees Celsius","*degree*C*", +"temperature_max_03","temperature_max_03","WorldClim_2.1_UKESM1-0-LL_ssp126_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Mar","max T Mar","march","degrees Celsius","*degree*C*", +"temperature_max_04","temperature_max_04","WorldClim_2.1_UKESM1-0-LL_ssp126_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Apr","max T Apr","april","degrees Celsius","*degree*C*", +"temperature_max_05","temperature_max_05","WorldClim_2.1_UKESM1-0-LL_ssp126_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature May","max T May","may","degrees Celsius","*degree*C*", +"temperature_max_06","temperature_max_06","WorldClim_2.1_UKESM1-0-LL_ssp126_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jun","max T Jun","june","degrees Celsius","*degree*C*", +"temperature_max_07","temperature_max_07","WorldClim_2.1_UKESM1-0-LL_ssp126_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jul","max T Jul","july","degrees Celsius","*degree*C*", +"temperature_max_08","temperature_max_08","WorldClim_2.1_UKESM1-0-LL_ssp126_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Aug","max T Aug","august","degrees Celsius","*degree*C*", +"temperature_max_09","temperature_max_09","WorldClim_2.1_UKESM1-0-LL_ssp126_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Sep","max T Sep","september","degrees Celsius","*degree*C*", +"temperature_max_10","temperature_max_10","WorldClim_2.1_UKESM1-0-LL_ssp126_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Oct","max T Oct","october","degrees Celsius","*degree*C*", +"temperature_max_11","temperature_max_11","WorldClim_2.1_UKESM1-0-LL_ssp126_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Nov","max T Nov","november","degrees Celsius","*degree*C*", +"temperature_max_12","temperature_max_12","WorldClim_2.1_UKESM1-0-LL_ssp126_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp126_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Dec","max T Dec","december","degrees Celsius","*degree*C*", +"bio01","bio01","WorldClim_2.1_UKESM1-0-LL_ssp126_5m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual mean temperature","ann. mean T","year","degrees Celsius","*degree*C*", +"bio02","bio02","WorldClim_2.1_UKESM1-0-LL_ssp126_5m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean diurnal range","diurn. range","year","degrees Celsius","*degree*C*", +"bio03","bio03","WorldClim_2.1_UKESM1-0-LL_ssp126_5m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","isothermality","isothermality","year","","", +"bio04","bio04","WorldClim_2.1_UKESM1-0-LL_ssp126_5m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature seasonality","T season.","year","degrees Celsius","*degree*C*", +"bio05","bio05","WorldClim_2.1_UKESM1-0-LL_ssp126_5m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature of warmest month","max. T of warmest mo.","year","degrees Celsius","*degree*C*", +"bio06","bio06","WorldClim_2.1_UKESM1-0-LL_ssp126_5m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature of coldest month","min. T of coldest mo.","year","degrees Celsius","*degree*C*", +"bio07","bio07","WorldClim_2.1_UKESM1-0-LL_ssp126_5m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature annual range (bio05-bio06)","T ann. Range","year","degrees Celsius","*degree*C*", +"bio08","bio08","WorldClim_2.1_UKESM1-0-LL_ssp126_5m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of wettest quarter","mean T of wettest qtr","year","degrees Celsius","*degree*C*", +"bio09","bio09","WorldClim_2.1_UKESM1-0-LL_ssp126_5m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of driest quarter","mean T of driest qtr","year","degrees Celsius","*degree*C*", +"bio10","bio10","WorldClim_2.1_UKESM1-0-LL_ssp126_5m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of warmest quarter","mean T of warmest qtr","year","degrees Celsius","*degree*C*", +"bio11","bio11","WorldClim_2.1_UKESM1-0-LL_ssp126_5m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of coldest quarter","mean T of coldest qtr","year","degrees Celsius","*degree*C*", +"bio12","bio12","WorldClim_2.1_UKESM1-0-LL_ssp126_5m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual precipitation","ann. P","year","mm per year","*mm~yr^-1*", +"bio13","bio13","WorldClim_2.1_UKESM1-0-LL_ssp126_5m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest month","P of wettest mo.","year","mm per month","*mm~mo^-1*", +"bio14","bio14","WorldClim_2.1_UKESM1-0-LL_ssp126_5m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest month","P of driest mo.","year","mm per month","*mm~mo^-1*", +"bio15","bio15","WorldClim_2.1_UKESM1-0-LL_ssp126_5m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation seasonality (coeff var)","P season.","year","","", +"bio16","bio16","WorldClim_2.1_UKESM1-0-LL_ssp126_5m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest quarter","P of wettest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio17","bio17","WorldClim_2.1_UKESM1-0-LL_ssp126_5m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest quarter","P of driest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio18","bio18","WorldClim_2.1_UKESM1-0-LL_ssp126_5m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of warmest quarter","P of warmest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio19","bio19","WorldClim_2.1_UKESM1-0-LL_ssp126_5m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp126_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of coldest quarter","P of coldest qtr","year","mm per quarter","*mm~qtr^-1*", +"precipitation_01","precipitation_01","WorldClim_2.1_UKESM1-0-LL_ssp126_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jan","P Jan","january","mm per month","*mm~mo^-1*", +"precipitation_02","precipitation_02","WorldClim_2.1_UKESM1-0-LL_ssp126_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Feb","P Feb","february","mm per month","*mm~mo^-1*", +"precipitation_03","precipitation_03","WorldClim_2.1_UKESM1-0-LL_ssp126_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Mar","P Mar","march","mm per month","*mm~mo^-1*", +"precipitation_04","precipitation_04","WorldClim_2.1_UKESM1-0-LL_ssp126_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Apr","P Apr","april","mm per month","*mm~mo^-1*", +"precipitation_05","precipitation_05","WorldClim_2.1_UKESM1-0-LL_ssp126_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation May","P May","may","mm per month","*mm~mo^-1*", +"precipitation_06","precipitation_06","WorldClim_2.1_UKESM1-0-LL_ssp126_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jun","P Jun","june","mm per month","*mm~mo^-1*", +"precipitation_07","precipitation_07","WorldClim_2.1_UKESM1-0-LL_ssp126_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jul","P Jul","july","mm per month","*mm~mo^-1*", +"precipitation_08","precipitation_08","WorldClim_2.1_UKESM1-0-LL_ssp126_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Aug","P Aug","august","mm per month","*mm~mo^-1*", +"precipitation_09","precipitation_09","WorldClim_2.1_UKESM1-0-LL_ssp126_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Sep","P Sep","september","mm per month","*mm~mo^-1*", +"precipitation_10","precipitation_10","WorldClim_2.1_UKESM1-0-LL_ssp126_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Oct","P Oct","october","mm per month","*mm~mo^-1*", +"precipitation_11","precipitation_11","WorldClim_2.1_UKESM1-0-LL_ssp126_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Nov","P Nov","november","mm per month","*mm~mo^-1*", +"precipitation_12","precipitation_12","WorldClim_2.1_UKESM1-0-LL_ssp126_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp126_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Dec","P Dec","december","mm per month","*mm~mo^-1*", +"temperature_min_01","temperature_min_01","WorldClim_2.1_UKESM1-0-LL_ssp126_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jan","min T Jan","january","degrees Celsius","*degree*C*", +"temperature_min_02","temperature_min_02","WorldClim_2.1_UKESM1-0-LL_ssp126_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Feb","min T Feb","february","degrees Celsius","*degree*C*", +"temperature_min_03","temperature_min_03","WorldClim_2.1_UKESM1-0-LL_ssp126_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Mar","min T Mar","march","degrees Celsius","*degree*C*", +"temperature_min_04","temperature_min_04","WorldClim_2.1_UKESM1-0-LL_ssp126_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Apr","min T Apr","april","degrees Celsius","*degree*C*", +"temperature_min_05","temperature_min_05","WorldClim_2.1_UKESM1-0-LL_ssp126_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature May","min T May","may","degrees Celsius","*degree*C*", +"temperature_min_06","temperature_min_06","WorldClim_2.1_UKESM1-0-LL_ssp126_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jun","min T Jun","june","degrees Celsius","*degree*C*", +"temperature_min_07","temperature_min_07","WorldClim_2.1_UKESM1-0-LL_ssp126_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jul","min T Jul","july","degrees Celsius","*degree*C*", +"temperature_min_08","temperature_min_08","WorldClim_2.1_UKESM1-0-LL_ssp126_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Aug","min T Aug","august","degrees Celsius","*degree*C*", +"temperature_min_09","temperature_min_09","WorldClim_2.1_UKESM1-0-LL_ssp126_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Sep","min T Sep","september","degrees Celsius","*degree*C*", +"temperature_min_10","temperature_min_10","WorldClim_2.1_UKESM1-0-LL_ssp126_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Oct","min T Oct","october","degrees Celsius","*degree*C*", +"temperature_min_11","temperature_min_11","WorldClim_2.1_UKESM1-0-LL_ssp126_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Nov","min T Nov","november","degrees Celsius","*degree*C*", +"temperature_min_12","temperature_min_12","WorldClim_2.1_UKESM1-0-LL_ssp126_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp126_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Dec","min T Dec","december","degrees Celsius","*degree*C*", +"temperature_max_01","temperature_max_01","WorldClim_2.1_UKESM1-0-LL_ssp126_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jan","max T Jan","january","degrees Celsius","*degree*C*", +"temperature_max_02","temperature_max_02","WorldClim_2.1_UKESM1-0-LL_ssp126_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Feb","max T Feb","february","degrees Celsius","*degree*C*", +"temperature_max_03","temperature_max_03","WorldClim_2.1_UKESM1-0-LL_ssp126_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Mar","max T Mar","march","degrees Celsius","*degree*C*", +"temperature_max_04","temperature_max_04","WorldClim_2.1_UKESM1-0-LL_ssp126_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Apr","max T Apr","april","degrees Celsius","*degree*C*", +"temperature_max_05","temperature_max_05","WorldClim_2.1_UKESM1-0-LL_ssp126_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature May","max T May","may","degrees Celsius","*degree*C*", +"temperature_max_06","temperature_max_06","WorldClim_2.1_UKESM1-0-LL_ssp126_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jun","max T Jun","june","degrees Celsius","*degree*C*", +"temperature_max_07","temperature_max_07","WorldClim_2.1_UKESM1-0-LL_ssp126_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jul","max T Jul","july","degrees Celsius","*degree*C*", +"temperature_max_08","temperature_max_08","WorldClim_2.1_UKESM1-0-LL_ssp126_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Aug","max T Aug","august","degrees Celsius","*degree*C*", +"temperature_max_09","temperature_max_09","WorldClim_2.1_UKESM1-0-LL_ssp126_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Sep","max T Sep","september","degrees Celsius","*degree*C*", +"temperature_max_10","temperature_max_10","WorldClim_2.1_UKESM1-0-LL_ssp126_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Oct","max T Oct","october","degrees Celsius","*degree*C*", +"temperature_max_11","temperature_max_11","WorldClim_2.1_UKESM1-0-LL_ssp126_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Nov","max T Nov","november","degrees Celsius","*degree*C*", +"temperature_max_12","temperature_max_12","WorldClim_2.1_UKESM1-0-LL_ssp126_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp126_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Dec","max T Dec","december","degrees Celsius","*degree*C*", +"bio01","bio01","WorldClim_2.1_UKESM1-0-LL_ssp245_10m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual mean temperature","ann. mean T","year","degrees Celsius","*degree*C*", +"bio02","bio02","WorldClim_2.1_UKESM1-0-LL_ssp245_10m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean diurnal range","diurn. range","year","degrees Celsius","*degree*C*", +"bio03","bio03","WorldClim_2.1_UKESM1-0-LL_ssp245_10m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","isothermality","isothermality","year","","", +"bio04","bio04","WorldClim_2.1_UKESM1-0-LL_ssp245_10m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature seasonality","T season.","year","degrees Celsius","*degree*C*", +"bio05","bio05","WorldClim_2.1_UKESM1-0-LL_ssp245_10m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature of warmest month","max. T of warmest mo.","year","degrees Celsius","*degree*C*", +"bio06","bio06","WorldClim_2.1_UKESM1-0-LL_ssp245_10m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature of coldest month","min. T of coldest mo.","year","degrees Celsius","*degree*C*", +"bio07","bio07","WorldClim_2.1_UKESM1-0-LL_ssp245_10m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature annual range (bio05-bio06)","T ann. Range","year","degrees Celsius","*degree*C*", +"bio08","bio08","WorldClim_2.1_UKESM1-0-LL_ssp245_10m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of wettest quarter","mean T of wettest qtr","year","degrees Celsius","*degree*C*", +"bio09","bio09","WorldClim_2.1_UKESM1-0-LL_ssp245_10m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of driest quarter","mean T of driest qtr","year","degrees Celsius","*degree*C*", +"bio10","bio10","WorldClim_2.1_UKESM1-0-LL_ssp245_10m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of warmest quarter","mean T of warmest qtr","year","degrees Celsius","*degree*C*", +"bio11","bio11","WorldClim_2.1_UKESM1-0-LL_ssp245_10m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of coldest quarter","mean T of coldest qtr","year","degrees Celsius","*degree*C*", +"bio12","bio12","WorldClim_2.1_UKESM1-0-LL_ssp245_10m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual precipitation","ann. P","year","mm per year","*mm~yr^-1*", +"bio13","bio13","WorldClim_2.1_UKESM1-0-LL_ssp245_10m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest month","P of wettest mo.","year","mm per month","*mm~mo^-1*", +"bio14","bio14","WorldClim_2.1_UKESM1-0-LL_ssp245_10m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest month","P of driest mo.","year","mm per month","*mm~mo^-1*", +"bio15","bio15","WorldClim_2.1_UKESM1-0-LL_ssp245_10m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation seasonality (coeff var)","P season.","year","","", +"bio16","bio16","WorldClim_2.1_UKESM1-0-LL_ssp245_10m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest quarter","P of wettest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio17","bio17","WorldClim_2.1_UKESM1-0-LL_ssp245_10m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest quarter","P of driest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio18","bio18","WorldClim_2.1_UKESM1-0-LL_ssp245_10m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of warmest quarter","P of warmest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio19","bio19","WorldClim_2.1_UKESM1-0-LL_ssp245_10m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp245_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of coldest quarter","P of coldest qtr","year","mm per quarter","*mm~qtr^-1*", +"precipitation_01","precipitation_01","WorldClim_2.1_UKESM1-0-LL_ssp245_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jan","P Jan","january","mm per month","*mm~mo^-1*", +"precipitation_02","precipitation_02","WorldClim_2.1_UKESM1-0-LL_ssp245_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Feb","P Feb","february","mm per month","*mm~mo^-1*", +"precipitation_03","precipitation_03","WorldClim_2.1_UKESM1-0-LL_ssp245_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Mar","P Mar","march","mm per month","*mm~mo^-1*", +"precipitation_04","precipitation_04","WorldClim_2.1_UKESM1-0-LL_ssp245_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Apr","P Apr","april","mm per month","*mm~mo^-1*", +"precipitation_05","precipitation_05","WorldClim_2.1_UKESM1-0-LL_ssp245_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation May","P May","may","mm per month","*mm~mo^-1*", +"precipitation_06","precipitation_06","WorldClim_2.1_UKESM1-0-LL_ssp245_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jun","P Jun","june","mm per month","*mm~mo^-1*", +"precipitation_07","precipitation_07","WorldClim_2.1_UKESM1-0-LL_ssp245_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jul","P Jul","july","mm per month","*mm~mo^-1*", +"precipitation_08","precipitation_08","WorldClim_2.1_UKESM1-0-LL_ssp245_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Aug","P Aug","august","mm per month","*mm~mo^-1*", +"precipitation_09","precipitation_09","WorldClim_2.1_UKESM1-0-LL_ssp245_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Sep","P Sep","september","mm per month","*mm~mo^-1*", +"precipitation_10","precipitation_10","WorldClim_2.1_UKESM1-0-LL_ssp245_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Oct","P Oct","october","mm per month","*mm~mo^-1*", +"precipitation_11","precipitation_11","WorldClim_2.1_UKESM1-0-LL_ssp245_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Nov","P Nov","november","mm per month","*mm~mo^-1*", +"precipitation_12","precipitation_12","WorldClim_2.1_UKESM1-0-LL_ssp245_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp245_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Dec","P Dec","december","mm per month","*mm~mo^-1*", +"temperature_min_01","temperature_min_01","WorldClim_2.1_UKESM1-0-LL_ssp245_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jan","min T Jan","january","degrees Celsius","*degree*C*", +"temperature_min_02","temperature_min_02","WorldClim_2.1_UKESM1-0-LL_ssp245_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Feb","min T Feb","february","degrees Celsius","*degree*C*", +"temperature_min_03","temperature_min_03","WorldClim_2.1_UKESM1-0-LL_ssp245_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Mar","min T Mar","march","degrees Celsius","*degree*C*", +"temperature_min_04","temperature_min_04","WorldClim_2.1_UKESM1-0-LL_ssp245_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Apr","min T Apr","april","degrees Celsius","*degree*C*", +"temperature_min_05","temperature_min_05","WorldClim_2.1_UKESM1-0-LL_ssp245_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature May","min T May","may","degrees Celsius","*degree*C*", +"temperature_min_06","temperature_min_06","WorldClim_2.1_UKESM1-0-LL_ssp245_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jun","min T Jun","june","degrees Celsius","*degree*C*", +"temperature_min_07","temperature_min_07","WorldClim_2.1_UKESM1-0-LL_ssp245_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jul","min T Jul","july","degrees Celsius","*degree*C*", +"temperature_min_08","temperature_min_08","WorldClim_2.1_UKESM1-0-LL_ssp245_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Aug","min T Aug","august","degrees Celsius","*degree*C*", +"temperature_min_09","temperature_min_09","WorldClim_2.1_UKESM1-0-LL_ssp245_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Sep","min T Sep","september","degrees Celsius","*degree*C*", +"temperature_min_10","temperature_min_10","WorldClim_2.1_UKESM1-0-LL_ssp245_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Oct","min T Oct","october","degrees Celsius","*degree*C*", +"temperature_min_11","temperature_min_11","WorldClim_2.1_UKESM1-0-LL_ssp245_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Nov","min T Nov","november","degrees Celsius","*degree*C*", +"temperature_min_12","temperature_min_12","WorldClim_2.1_UKESM1-0-LL_ssp245_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp245_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Dec","min T Dec","december","degrees Celsius","*degree*C*", +"temperature_max_01","temperature_max_01","WorldClim_2.1_UKESM1-0-LL_ssp245_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jan","max T Jan","january","degrees Celsius","*degree*C*", +"temperature_max_02","temperature_max_02","WorldClim_2.1_UKESM1-0-LL_ssp245_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Feb","max T Feb","february","degrees Celsius","*degree*C*", +"temperature_max_03","temperature_max_03","WorldClim_2.1_UKESM1-0-LL_ssp245_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Mar","max T Mar","march","degrees Celsius","*degree*C*", +"temperature_max_04","temperature_max_04","WorldClim_2.1_UKESM1-0-LL_ssp245_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Apr","max T Apr","april","degrees Celsius","*degree*C*", +"temperature_max_05","temperature_max_05","WorldClim_2.1_UKESM1-0-LL_ssp245_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature May","max T May","may","degrees Celsius","*degree*C*", +"temperature_max_06","temperature_max_06","WorldClim_2.1_UKESM1-0-LL_ssp245_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jun","max T Jun","june","degrees Celsius","*degree*C*", +"temperature_max_07","temperature_max_07","WorldClim_2.1_UKESM1-0-LL_ssp245_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jul","max T Jul","july","degrees Celsius","*degree*C*", +"temperature_max_08","temperature_max_08","WorldClim_2.1_UKESM1-0-LL_ssp245_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Aug","max T Aug","august","degrees Celsius","*degree*C*", +"temperature_max_09","temperature_max_09","WorldClim_2.1_UKESM1-0-LL_ssp245_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Sep","max T Sep","september","degrees Celsius","*degree*C*", +"temperature_max_10","temperature_max_10","WorldClim_2.1_UKESM1-0-LL_ssp245_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Oct","max T Oct","october","degrees Celsius","*degree*C*", +"temperature_max_11","temperature_max_11","WorldClim_2.1_UKESM1-0-LL_ssp245_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Nov","max T Nov","november","degrees Celsius","*degree*C*", +"temperature_max_12","temperature_max_12","WorldClim_2.1_UKESM1-0-LL_ssp245_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp245_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Dec","max T Dec","december","degrees Celsius","*degree*C*", +"bio01","bio01","WorldClim_2.1_UKESM1-0-LL_ssp245_5m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual mean temperature","ann. mean T","year","degrees Celsius","*degree*C*", +"bio02","bio02","WorldClim_2.1_UKESM1-0-LL_ssp245_5m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean diurnal range","diurn. range","year","degrees Celsius","*degree*C*", +"bio03","bio03","WorldClim_2.1_UKESM1-0-LL_ssp245_5m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","isothermality","isothermality","year","","", +"bio04","bio04","WorldClim_2.1_UKESM1-0-LL_ssp245_5m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature seasonality","T season.","year","degrees Celsius","*degree*C*", +"bio05","bio05","WorldClim_2.1_UKESM1-0-LL_ssp245_5m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature of warmest month","max. T of warmest mo.","year","degrees Celsius","*degree*C*", +"bio06","bio06","WorldClim_2.1_UKESM1-0-LL_ssp245_5m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature of coldest month","min. T of coldest mo.","year","degrees Celsius","*degree*C*", +"bio07","bio07","WorldClim_2.1_UKESM1-0-LL_ssp245_5m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature annual range (bio05-bio06)","T ann. Range","year","degrees Celsius","*degree*C*", +"bio08","bio08","WorldClim_2.1_UKESM1-0-LL_ssp245_5m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of wettest quarter","mean T of wettest qtr","year","degrees Celsius","*degree*C*", +"bio09","bio09","WorldClim_2.1_UKESM1-0-LL_ssp245_5m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of driest quarter","mean T of driest qtr","year","degrees Celsius","*degree*C*", +"bio10","bio10","WorldClim_2.1_UKESM1-0-LL_ssp245_5m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of warmest quarter","mean T of warmest qtr","year","degrees Celsius","*degree*C*", +"bio11","bio11","WorldClim_2.1_UKESM1-0-LL_ssp245_5m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of coldest quarter","mean T of coldest qtr","year","degrees Celsius","*degree*C*", +"bio12","bio12","WorldClim_2.1_UKESM1-0-LL_ssp245_5m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual precipitation","ann. P","year","mm per year","*mm~yr^-1*", +"bio13","bio13","WorldClim_2.1_UKESM1-0-LL_ssp245_5m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest month","P of wettest mo.","year","mm per month","*mm~mo^-1*", +"bio14","bio14","WorldClim_2.1_UKESM1-0-LL_ssp245_5m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest month","P of driest mo.","year","mm per month","*mm~mo^-1*", +"bio15","bio15","WorldClim_2.1_UKESM1-0-LL_ssp245_5m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation seasonality (coeff var)","P season.","year","","", +"bio16","bio16","WorldClim_2.1_UKESM1-0-LL_ssp245_5m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest quarter","P of wettest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio17","bio17","WorldClim_2.1_UKESM1-0-LL_ssp245_5m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest quarter","P of driest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio18","bio18","WorldClim_2.1_UKESM1-0-LL_ssp245_5m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of warmest quarter","P of warmest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio19","bio19","WorldClim_2.1_UKESM1-0-LL_ssp245_5m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp245_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of coldest quarter","P of coldest qtr","year","mm per quarter","*mm~qtr^-1*", +"precipitation_01","precipitation_01","WorldClim_2.1_UKESM1-0-LL_ssp245_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jan","P Jan","january","mm per month","*mm~mo^-1*", +"precipitation_02","precipitation_02","WorldClim_2.1_UKESM1-0-LL_ssp245_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Feb","P Feb","february","mm per month","*mm~mo^-1*", +"precipitation_03","precipitation_03","WorldClim_2.1_UKESM1-0-LL_ssp245_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Mar","P Mar","march","mm per month","*mm~mo^-1*", +"precipitation_04","precipitation_04","WorldClim_2.1_UKESM1-0-LL_ssp245_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Apr","P Apr","april","mm per month","*mm~mo^-1*", +"precipitation_05","precipitation_05","WorldClim_2.1_UKESM1-0-LL_ssp245_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation May","P May","may","mm per month","*mm~mo^-1*", +"precipitation_06","precipitation_06","WorldClim_2.1_UKESM1-0-LL_ssp245_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jun","P Jun","june","mm per month","*mm~mo^-1*", +"precipitation_07","precipitation_07","WorldClim_2.1_UKESM1-0-LL_ssp245_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jul","P Jul","july","mm per month","*mm~mo^-1*", +"precipitation_08","precipitation_08","WorldClim_2.1_UKESM1-0-LL_ssp245_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Aug","P Aug","august","mm per month","*mm~mo^-1*", +"precipitation_09","precipitation_09","WorldClim_2.1_UKESM1-0-LL_ssp245_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Sep","P Sep","september","mm per month","*mm~mo^-1*", +"precipitation_10","precipitation_10","WorldClim_2.1_UKESM1-0-LL_ssp245_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Oct","P Oct","october","mm per month","*mm~mo^-1*", +"precipitation_11","precipitation_11","WorldClim_2.1_UKESM1-0-LL_ssp245_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Nov","P Nov","november","mm per month","*mm~mo^-1*", +"precipitation_12","precipitation_12","WorldClim_2.1_UKESM1-0-LL_ssp245_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp245_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Dec","P Dec","december","mm per month","*mm~mo^-1*", +"temperature_min_01","temperature_min_01","WorldClim_2.1_UKESM1-0-LL_ssp245_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jan","min T Jan","january","degrees Celsius","*degree*C*", +"temperature_min_02","temperature_min_02","WorldClim_2.1_UKESM1-0-LL_ssp245_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Feb","min T Feb","february","degrees Celsius","*degree*C*", +"temperature_min_03","temperature_min_03","WorldClim_2.1_UKESM1-0-LL_ssp245_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Mar","min T Mar","march","degrees Celsius","*degree*C*", +"temperature_min_04","temperature_min_04","WorldClim_2.1_UKESM1-0-LL_ssp245_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Apr","min T Apr","april","degrees Celsius","*degree*C*", +"temperature_min_05","temperature_min_05","WorldClim_2.1_UKESM1-0-LL_ssp245_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature May","min T May","may","degrees Celsius","*degree*C*", +"temperature_min_06","temperature_min_06","WorldClim_2.1_UKESM1-0-LL_ssp245_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jun","min T Jun","june","degrees Celsius","*degree*C*", +"temperature_min_07","temperature_min_07","WorldClim_2.1_UKESM1-0-LL_ssp245_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jul","min T Jul","july","degrees Celsius","*degree*C*", +"temperature_min_08","temperature_min_08","WorldClim_2.1_UKESM1-0-LL_ssp245_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Aug","min T Aug","august","degrees Celsius","*degree*C*", +"temperature_min_09","temperature_min_09","WorldClim_2.1_UKESM1-0-LL_ssp245_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Sep","min T Sep","september","degrees Celsius","*degree*C*", +"temperature_min_10","temperature_min_10","WorldClim_2.1_UKESM1-0-LL_ssp245_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Oct","min T Oct","october","degrees Celsius","*degree*C*", +"temperature_min_11","temperature_min_11","WorldClim_2.1_UKESM1-0-LL_ssp245_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Nov","min T Nov","november","degrees Celsius","*degree*C*", +"temperature_min_12","temperature_min_12","WorldClim_2.1_UKESM1-0-LL_ssp245_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp245_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Dec","min T Dec","december","degrees Celsius","*degree*C*", +"temperature_max_01","temperature_max_01","WorldClim_2.1_UKESM1-0-LL_ssp245_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jan","max T Jan","january","degrees Celsius","*degree*C*", +"temperature_max_02","temperature_max_02","WorldClim_2.1_UKESM1-0-LL_ssp245_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Feb","max T Feb","february","degrees Celsius","*degree*C*", +"temperature_max_03","temperature_max_03","WorldClim_2.1_UKESM1-0-LL_ssp245_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Mar","max T Mar","march","degrees Celsius","*degree*C*", +"temperature_max_04","temperature_max_04","WorldClim_2.1_UKESM1-0-LL_ssp245_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Apr","max T Apr","april","degrees Celsius","*degree*C*", +"temperature_max_05","temperature_max_05","WorldClim_2.1_UKESM1-0-LL_ssp245_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature May","max T May","may","degrees Celsius","*degree*C*", +"temperature_max_06","temperature_max_06","WorldClim_2.1_UKESM1-0-LL_ssp245_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jun","max T Jun","june","degrees Celsius","*degree*C*", +"temperature_max_07","temperature_max_07","WorldClim_2.1_UKESM1-0-LL_ssp245_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jul","max T Jul","july","degrees Celsius","*degree*C*", +"temperature_max_08","temperature_max_08","WorldClim_2.1_UKESM1-0-LL_ssp245_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Aug","max T Aug","august","degrees Celsius","*degree*C*", +"temperature_max_09","temperature_max_09","WorldClim_2.1_UKESM1-0-LL_ssp245_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Sep","max T Sep","september","degrees Celsius","*degree*C*", +"temperature_max_10","temperature_max_10","WorldClim_2.1_UKESM1-0-LL_ssp245_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Oct","max T Oct","october","degrees Celsius","*degree*C*", +"temperature_max_11","temperature_max_11","WorldClim_2.1_UKESM1-0-LL_ssp245_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Nov","max T Nov","november","degrees Celsius","*degree*C*", +"temperature_max_12","temperature_max_12","WorldClim_2.1_UKESM1-0-LL_ssp245_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp245_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Dec","max T Dec","december","degrees Celsius","*degree*C*", +"bio01","bio01","WorldClim_2.1_UKESM1-0-LL_ssp370_10m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual mean temperature","ann. mean T","year","degrees Celsius","*degree*C*", +"bio02","bio02","WorldClim_2.1_UKESM1-0-LL_ssp370_10m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean diurnal range","diurn. range","year","degrees Celsius","*degree*C*", +"bio03","bio03","WorldClim_2.1_UKESM1-0-LL_ssp370_10m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","isothermality","isothermality","year","","", +"bio04","bio04","WorldClim_2.1_UKESM1-0-LL_ssp370_10m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature seasonality","T season.","year","degrees Celsius","*degree*C*", +"bio05","bio05","WorldClim_2.1_UKESM1-0-LL_ssp370_10m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature of warmest month","max. T of warmest mo.","year","degrees Celsius","*degree*C*", +"bio06","bio06","WorldClim_2.1_UKESM1-0-LL_ssp370_10m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature of coldest month","min. T of coldest mo.","year","degrees Celsius","*degree*C*", +"bio07","bio07","WorldClim_2.1_UKESM1-0-LL_ssp370_10m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature annual range (bio05-bio06)","T ann. Range","year","degrees Celsius","*degree*C*", +"bio08","bio08","WorldClim_2.1_UKESM1-0-LL_ssp370_10m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of wettest quarter","mean T of wettest qtr","year","degrees Celsius","*degree*C*", +"bio09","bio09","WorldClim_2.1_UKESM1-0-LL_ssp370_10m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of driest quarter","mean T of driest qtr","year","degrees Celsius","*degree*C*", +"bio10","bio10","WorldClim_2.1_UKESM1-0-LL_ssp370_10m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of warmest quarter","mean T of warmest qtr","year","degrees Celsius","*degree*C*", +"bio11","bio11","WorldClim_2.1_UKESM1-0-LL_ssp370_10m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of coldest quarter","mean T of coldest qtr","year","degrees Celsius","*degree*C*", +"bio12","bio12","WorldClim_2.1_UKESM1-0-LL_ssp370_10m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual precipitation","ann. P","year","mm per year","*mm~yr^-1*", +"bio13","bio13","WorldClim_2.1_UKESM1-0-LL_ssp370_10m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest month","P of wettest mo.","year","mm per month","*mm~mo^-1*", +"bio14","bio14","WorldClim_2.1_UKESM1-0-LL_ssp370_10m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest month","P of driest mo.","year","mm per month","*mm~mo^-1*", +"bio15","bio15","WorldClim_2.1_UKESM1-0-LL_ssp370_10m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation seasonality (coeff var)","P season.","year","","", +"bio16","bio16","WorldClim_2.1_UKESM1-0-LL_ssp370_10m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest quarter","P of wettest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio17","bio17","WorldClim_2.1_UKESM1-0-LL_ssp370_10m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest quarter","P of driest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio18","bio18","WorldClim_2.1_UKESM1-0-LL_ssp370_10m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of warmest quarter","P of warmest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio19","bio19","WorldClim_2.1_UKESM1-0-LL_ssp370_10m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp370_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of coldest quarter","P of coldest qtr","year","mm per quarter","*mm~qtr^-1*", +"precipitation_01","precipitation_01","WorldClim_2.1_UKESM1-0-LL_ssp370_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jan","P Jan","january","mm per month","*mm~mo^-1*", +"precipitation_02","precipitation_02","WorldClim_2.1_UKESM1-0-LL_ssp370_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Feb","P Feb","february","mm per month","*mm~mo^-1*", +"precipitation_03","precipitation_03","WorldClim_2.1_UKESM1-0-LL_ssp370_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Mar","P Mar","march","mm per month","*mm~mo^-1*", +"precipitation_04","precipitation_04","WorldClim_2.1_UKESM1-0-LL_ssp370_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Apr","P Apr","april","mm per month","*mm~mo^-1*", +"precipitation_05","precipitation_05","WorldClim_2.1_UKESM1-0-LL_ssp370_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation May","P May","may","mm per month","*mm~mo^-1*", +"precipitation_06","precipitation_06","WorldClim_2.1_UKESM1-0-LL_ssp370_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jun","P Jun","june","mm per month","*mm~mo^-1*", +"precipitation_07","precipitation_07","WorldClim_2.1_UKESM1-0-LL_ssp370_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jul","P Jul","july","mm per month","*mm~mo^-1*", +"precipitation_08","precipitation_08","WorldClim_2.1_UKESM1-0-LL_ssp370_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Aug","P Aug","august","mm per month","*mm~mo^-1*", +"precipitation_09","precipitation_09","WorldClim_2.1_UKESM1-0-LL_ssp370_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Sep","P Sep","september","mm per month","*mm~mo^-1*", +"precipitation_10","precipitation_10","WorldClim_2.1_UKESM1-0-LL_ssp370_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Oct","P Oct","october","mm per month","*mm~mo^-1*", +"precipitation_11","precipitation_11","WorldClim_2.1_UKESM1-0-LL_ssp370_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Nov","P Nov","november","mm per month","*mm~mo^-1*", +"precipitation_12","precipitation_12","WorldClim_2.1_UKESM1-0-LL_ssp370_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp370_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Dec","P Dec","december","mm per month","*mm~mo^-1*", +"temperature_min_01","temperature_min_01","WorldClim_2.1_UKESM1-0-LL_ssp370_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jan","min T Jan","january","degrees Celsius","*degree*C*", +"temperature_min_02","temperature_min_02","WorldClim_2.1_UKESM1-0-LL_ssp370_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Feb","min T Feb","february","degrees Celsius","*degree*C*", +"temperature_min_03","temperature_min_03","WorldClim_2.1_UKESM1-0-LL_ssp370_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Mar","min T Mar","march","degrees Celsius","*degree*C*", +"temperature_min_04","temperature_min_04","WorldClim_2.1_UKESM1-0-LL_ssp370_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Apr","min T Apr","april","degrees Celsius","*degree*C*", +"temperature_min_05","temperature_min_05","WorldClim_2.1_UKESM1-0-LL_ssp370_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature May","min T May","may","degrees Celsius","*degree*C*", +"temperature_min_06","temperature_min_06","WorldClim_2.1_UKESM1-0-LL_ssp370_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jun","min T Jun","june","degrees Celsius","*degree*C*", +"temperature_min_07","temperature_min_07","WorldClim_2.1_UKESM1-0-LL_ssp370_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jul","min T Jul","july","degrees Celsius","*degree*C*", +"temperature_min_08","temperature_min_08","WorldClim_2.1_UKESM1-0-LL_ssp370_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Aug","min T Aug","august","degrees Celsius","*degree*C*", +"temperature_min_09","temperature_min_09","WorldClim_2.1_UKESM1-0-LL_ssp370_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Sep","min T Sep","september","degrees Celsius","*degree*C*", +"temperature_min_10","temperature_min_10","WorldClim_2.1_UKESM1-0-LL_ssp370_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Oct","min T Oct","october","degrees Celsius","*degree*C*", +"temperature_min_11","temperature_min_11","WorldClim_2.1_UKESM1-0-LL_ssp370_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Nov","min T Nov","november","degrees Celsius","*degree*C*", +"temperature_min_12","temperature_min_12","WorldClim_2.1_UKESM1-0-LL_ssp370_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp370_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Dec","min T Dec","december","degrees Celsius","*degree*C*", +"temperature_max_01","temperature_max_01","WorldClim_2.1_UKESM1-0-LL_ssp370_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jan","max T Jan","january","degrees Celsius","*degree*C*", +"temperature_max_02","temperature_max_02","WorldClim_2.1_UKESM1-0-LL_ssp370_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Feb","max T Feb","february","degrees Celsius","*degree*C*", +"temperature_max_03","temperature_max_03","WorldClim_2.1_UKESM1-0-LL_ssp370_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Mar","max T Mar","march","degrees Celsius","*degree*C*", +"temperature_max_04","temperature_max_04","WorldClim_2.1_UKESM1-0-LL_ssp370_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Apr","max T Apr","april","degrees Celsius","*degree*C*", +"temperature_max_05","temperature_max_05","WorldClim_2.1_UKESM1-0-LL_ssp370_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature May","max T May","may","degrees Celsius","*degree*C*", +"temperature_max_06","temperature_max_06","WorldClim_2.1_UKESM1-0-LL_ssp370_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jun","max T Jun","june","degrees Celsius","*degree*C*", +"temperature_max_07","temperature_max_07","WorldClim_2.1_UKESM1-0-LL_ssp370_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jul","max T Jul","july","degrees Celsius","*degree*C*", +"temperature_max_08","temperature_max_08","WorldClim_2.1_UKESM1-0-LL_ssp370_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Aug","max T Aug","august","degrees Celsius","*degree*C*", +"temperature_max_09","temperature_max_09","WorldClim_2.1_UKESM1-0-LL_ssp370_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Sep","max T Sep","september","degrees Celsius","*degree*C*", +"temperature_max_10","temperature_max_10","WorldClim_2.1_UKESM1-0-LL_ssp370_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Oct","max T Oct","october","degrees Celsius","*degree*C*", +"temperature_max_11","temperature_max_11","WorldClim_2.1_UKESM1-0-LL_ssp370_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Nov","max T Nov","november","degrees Celsius","*degree*C*", +"temperature_max_12","temperature_max_12","WorldClim_2.1_UKESM1-0-LL_ssp370_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp370_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Dec","max T Dec","december","degrees Celsius","*degree*C*", +"bio01","bio01","WorldClim_2.1_UKESM1-0-LL_ssp370_5m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual mean temperature","ann. mean T","year","degrees Celsius","*degree*C*", +"bio02","bio02","WorldClim_2.1_UKESM1-0-LL_ssp370_5m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean diurnal range","diurn. range","year","degrees Celsius","*degree*C*", +"bio03","bio03","WorldClim_2.1_UKESM1-0-LL_ssp370_5m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","isothermality","isothermality","year","","", +"bio04","bio04","WorldClim_2.1_UKESM1-0-LL_ssp370_5m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature seasonality","T season.","year","degrees Celsius","*degree*C*", +"bio05","bio05","WorldClim_2.1_UKESM1-0-LL_ssp370_5m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature of warmest month","max. T of warmest mo.","year","degrees Celsius","*degree*C*", +"bio06","bio06","WorldClim_2.1_UKESM1-0-LL_ssp370_5m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature of coldest month","min. T of coldest mo.","year","degrees Celsius","*degree*C*", +"bio07","bio07","WorldClim_2.1_UKESM1-0-LL_ssp370_5m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature annual range (bio05-bio06)","T ann. Range","year","degrees Celsius","*degree*C*", +"bio08","bio08","WorldClim_2.1_UKESM1-0-LL_ssp370_5m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of wettest quarter","mean T of wettest qtr","year","degrees Celsius","*degree*C*", +"bio09","bio09","WorldClim_2.1_UKESM1-0-LL_ssp370_5m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of driest quarter","mean T of driest qtr","year","degrees Celsius","*degree*C*", +"bio10","bio10","WorldClim_2.1_UKESM1-0-LL_ssp370_5m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of warmest quarter","mean T of warmest qtr","year","degrees Celsius","*degree*C*", +"bio11","bio11","WorldClim_2.1_UKESM1-0-LL_ssp370_5m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of coldest quarter","mean T of coldest qtr","year","degrees Celsius","*degree*C*", +"bio12","bio12","WorldClim_2.1_UKESM1-0-LL_ssp370_5m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual precipitation","ann. P","year","mm per year","*mm~yr^-1*", +"bio13","bio13","WorldClim_2.1_UKESM1-0-LL_ssp370_5m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest month","P of wettest mo.","year","mm per month","*mm~mo^-1*", +"bio14","bio14","WorldClim_2.1_UKESM1-0-LL_ssp370_5m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest month","P of driest mo.","year","mm per month","*mm~mo^-1*", +"bio15","bio15","WorldClim_2.1_UKESM1-0-LL_ssp370_5m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation seasonality (coeff var)","P season.","year","","", +"bio16","bio16","WorldClim_2.1_UKESM1-0-LL_ssp370_5m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest quarter","P of wettest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio17","bio17","WorldClim_2.1_UKESM1-0-LL_ssp370_5m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest quarter","P of driest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio18","bio18","WorldClim_2.1_UKESM1-0-LL_ssp370_5m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of warmest quarter","P of warmest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio19","bio19","WorldClim_2.1_UKESM1-0-LL_ssp370_5m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp370_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of coldest quarter","P of coldest qtr","year","mm per quarter","*mm~qtr^-1*", +"precipitation_01","precipitation_01","WorldClim_2.1_UKESM1-0-LL_ssp370_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jan","P Jan","january","mm per month","*mm~mo^-1*", +"precipitation_02","precipitation_02","WorldClim_2.1_UKESM1-0-LL_ssp370_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Feb","P Feb","february","mm per month","*mm~mo^-1*", +"precipitation_03","precipitation_03","WorldClim_2.1_UKESM1-0-LL_ssp370_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Mar","P Mar","march","mm per month","*mm~mo^-1*", +"precipitation_04","precipitation_04","WorldClim_2.1_UKESM1-0-LL_ssp370_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Apr","P Apr","april","mm per month","*mm~mo^-1*", +"precipitation_05","precipitation_05","WorldClim_2.1_UKESM1-0-LL_ssp370_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation May","P May","may","mm per month","*mm~mo^-1*", +"precipitation_06","precipitation_06","WorldClim_2.1_UKESM1-0-LL_ssp370_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jun","P Jun","june","mm per month","*mm~mo^-1*", +"precipitation_07","precipitation_07","WorldClim_2.1_UKESM1-0-LL_ssp370_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jul","P Jul","july","mm per month","*mm~mo^-1*", +"precipitation_08","precipitation_08","WorldClim_2.1_UKESM1-0-LL_ssp370_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Aug","P Aug","august","mm per month","*mm~mo^-1*", +"precipitation_09","precipitation_09","WorldClim_2.1_UKESM1-0-LL_ssp370_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Sep","P Sep","september","mm per month","*mm~mo^-1*", +"precipitation_10","precipitation_10","WorldClim_2.1_UKESM1-0-LL_ssp370_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Oct","P Oct","october","mm per month","*mm~mo^-1*", +"precipitation_11","precipitation_11","WorldClim_2.1_UKESM1-0-LL_ssp370_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Nov","P Nov","november","mm per month","*mm~mo^-1*", +"precipitation_12","precipitation_12","WorldClim_2.1_UKESM1-0-LL_ssp370_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp370_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Dec","P Dec","december","mm per month","*mm~mo^-1*", +"temperature_min_01","temperature_min_01","WorldClim_2.1_UKESM1-0-LL_ssp370_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jan","min T Jan","january","degrees Celsius","*degree*C*", +"temperature_min_02","temperature_min_02","WorldClim_2.1_UKESM1-0-LL_ssp370_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Feb","min T Feb","february","degrees Celsius","*degree*C*", +"temperature_min_03","temperature_min_03","WorldClim_2.1_UKESM1-0-LL_ssp370_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Mar","min T Mar","march","degrees Celsius","*degree*C*", +"temperature_min_04","temperature_min_04","WorldClim_2.1_UKESM1-0-LL_ssp370_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Apr","min T Apr","april","degrees Celsius","*degree*C*", +"temperature_min_05","temperature_min_05","WorldClim_2.1_UKESM1-0-LL_ssp370_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature May","min T May","may","degrees Celsius","*degree*C*", +"temperature_min_06","temperature_min_06","WorldClim_2.1_UKESM1-0-LL_ssp370_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jun","min T Jun","june","degrees Celsius","*degree*C*", +"temperature_min_07","temperature_min_07","WorldClim_2.1_UKESM1-0-LL_ssp370_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jul","min T Jul","july","degrees Celsius","*degree*C*", +"temperature_min_08","temperature_min_08","WorldClim_2.1_UKESM1-0-LL_ssp370_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Aug","min T Aug","august","degrees Celsius","*degree*C*", +"temperature_min_09","temperature_min_09","WorldClim_2.1_UKESM1-0-LL_ssp370_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Sep","min T Sep","september","degrees Celsius","*degree*C*", +"temperature_min_10","temperature_min_10","WorldClim_2.1_UKESM1-0-LL_ssp370_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Oct","min T Oct","october","degrees Celsius","*degree*C*", +"temperature_min_11","temperature_min_11","WorldClim_2.1_UKESM1-0-LL_ssp370_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Nov","min T Nov","november","degrees Celsius","*degree*C*", +"temperature_min_12","temperature_min_12","WorldClim_2.1_UKESM1-0-LL_ssp370_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp370_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Dec","min T Dec","december","degrees Celsius","*degree*C*", +"temperature_max_01","temperature_max_01","WorldClim_2.1_UKESM1-0-LL_ssp370_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jan","max T Jan","january","degrees Celsius","*degree*C*", +"temperature_max_02","temperature_max_02","WorldClim_2.1_UKESM1-0-LL_ssp370_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Feb","max T Feb","february","degrees Celsius","*degree*C*", +"temperature_max_03","temperature_max_03","WorldClim_2.1_UKESM1-0-LL_ssp370_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Mar","max T Mar","march","degrees Celsius","*degree*C*", +"temperature_max_04","temperature_max_04","WorldClim_2.1_UKESM1-0-LL_ssp370_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Apr","max T Apr","april","degrees Celsius","*degree*C*", +"temperature_max_05","temperature_max_05","WorldClim_2.1_UKESM1-0-LL_ssp370_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature May","max T May","may","degrees Celsius","*degree*C*", +"temperature_max_06","temperature_max_06","WorldClim_2.1_UKESM1-0-LL_ssp370_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jun","max T Jun","june","degrees Celsius","*degree*C*", +"temperature_max_07","temperature_max_07","WorldClim_2.1_UKESM1-0-LL_ssp370_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jul","max T Jul","july","degrees Celsius","*degree*C*", +"temperature_max_08","temperature_max_08","WorldClim_2.1_UKESM1-0-LL_ssp370_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Aug","max T Aug","august","degrees Celsius","*degree*C*", +"temperature_max_09","temperature_max_09","WorldClim_2.1_UKESM1-0-LL_ssp370_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Sep","max T Sep","september","degrees Celsius","*degree*C*", +"temperature_max_10","temperature_max_10","WorldClim_2.1_UKESM1-0-LL_ssp370_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Oct","max T Oct","october","degrees Celsius","*degree*C*", +"temperature_max_11","temperature_max_11","WorldClim_2.1_UKESM1-0-LL_ssp370_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Nov","max T Nov","november","degrees Celsius","*degree*C*", +"temperature_max_12","temperature_max_12","WorldClim_2.1_UKESM1-0-LL_ssp370_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp370_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Dec","max T Dec","december","degrees Celsius","*degree*C*", +"bio01","bio01","WorldClim_2.1_UKESM1-0-LL_ssp585_10m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual mean temperature","ann. mean T","year","degrees Celsius","*degree*C*", +"bio02","bio02","WorldClim_2.1_UKESM1-0-LL_ssp585_10m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean diurnal range","diurn. range","year","degrees Celsius","*degree*C*", +"bio03","bio03","WorldClim_2.1_UKESM1-0-LL_ssp585_10m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","isothermality","isothermality","year","","", +"bio04","bio04","WorldClim_2.1_UKESM1-0-LL_ssp585_10m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature seasonality","T season.","year","degrees Celsius","*degree*C*", +"bio05","bio05","WorldClim_2.1_UKESM1-0-LL_ssp585_10m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature of warmest month","max. T of warmest mo.","year","degrees Celsius","*degree*C*", +"bio06","bio06","WorldClim_2.1_UKESM1-0-LL_ssp585_10m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature of coldest month","min. T of coldest mo.","year","degrees Celsius","*degree*C*", +"bio07","bio07","WorldClim_2.1_UKESM1-0-LL_ssp585_10m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature annual range (bio05-bio06)","T ann. Range","year","degrees Celsius","*degree*C*", +"bio08","bio08","WorldClim_2.1_UKESM1-0-LL_ssp585_10m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of wettest quarter","mean T of wettest qtr","year","degrees Celsius","*degree*C*", +"bio09","bio09","WorldClim_2.1_UKESM1-0-LL_ssp585_10m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of driest quarter","mean T of driest qtr","year","degrees Celsius","*degree*C*", +"bio10","bio10","WorldClim_2.1_UKESM1-0-LL_ssp585_10m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of warmest quarter","mean T of warmest qtr","year","degrees Celsius","*degree*C*", +"bio11","bio11","WorldClim_2.1_UKESM1-0-LL_ssp585_10m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of coldest quarter","mean T of coldest qtr","year","degrees Celsius","*degree*C*", +"bio12","bio12","WorldClim_2.1_UKESM1-0-LL_ssp585_10m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual precipitation","ann. P","year","mm per year","*mm~yr^-1*", +"bio13","bio13","WorldClim_2.1_UKESM1-0-LL_ssp585_10m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest month","P of wettest mo.","year","mm per month","*mm~mo^-1*", +"bio14","bio14","WorldClim_2.1_UKESM1-0-LL_ssp585_10m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest month","P of driest mo.","year","mm per month","*mm~mo^-1*", +"bio15","bio15","WorldClim_2.1_UKESM1-0-LL_ssp585_10m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation seasonality (coeff var)","P season.","year","","", +"bio16","bio16","WorldClim_2.1_UKESM1-0-LL_ssp585_10m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest quarter","P of wettest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio17","bio17","WorldClim_2.1_UKESM1-0-LL_ssp585_10m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest quarter","P of driest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio18","bio18","WorldClim_2.1_UKESM1-0-LL_ssp585_10m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of warmest quarter","P of warmest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio19","bio19","WorldClim_2.1_UKESM1-0-LL_ssp585_10m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp585_10m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of coldest quarter","P of coldest qtr","year","mm per quarter","*mm~qtr^-1*", +"precipitation_01","precipitation_01","WorldClim_2.1_UKESM1-0-LL_ssp585_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jan","P Jan","january","mm per month","*mm~mo^-1*", +"precipitation_02","precipitation_02","WorldClim_2.1_UKESM1-0-LL_ssp585_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Feb","P Feb","february","mm per month","*mm~mo^-1*", +"precipitation_03","precipitation_03","WorldClim_2.1_UKESM1-0-LL_ssp585_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Mar","P Mar","march","mm per month","*mm~mo^-1*", +"precipitation_04","precipitation_04","WorldClim_2.1_UKESM1-0-LL_ssp585_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Apr","P Apr","april","mm per month","*mm~mo^-1*", +"precipitation_05","precipitation_05","WorldClim_2.1_UKESM1-0-LL_ssp585_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation May","P May","may","mm per month","*mm~mo^-1*", +"precipitation_06","precipitation_06","WorldClim_2.1_UKESM1-0-LL_ssp585_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jun","P Jun","june","mm per month","*mm~mo^-1*", +"precipitation_07","precipitation_07","WorldClim_2.1_UKESM1-0-LL_ssp585_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jul","P Jul","july","mm per month","*mm~mo^-1*", +"precipitation_08","precipitation_08","WorldClim_2.1_UKESM1-0-LL_ssp585_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Aug","P Aug","august","mm per month","*mm~mo^-1*", +"precipitation_09","precipitation_09","WorldClim_2.1_UKESM1-0-LL_ssp585_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Sep","P Sep","september","mm per month","*mm~mo^-1*", +"precipitation_10","precipitation_10","WorldClim_2.1_UKESM1-0-LL_ssp585_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Oct","P Oct","october","mm per month","*mm~mo^-1*", +"precipitation_11","precipitation_11","WorldClim_2.1_UKESM1-0-LL_ssp585_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Nov","P Nov","november","mm per month","*mm~mo^-1*", +"precipitation_12","precipitation_12","WorldClim_2.1_UKESM1-0-LL_ssp585_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp585_10m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Dec","P Dec","december","mm per month","*mm~mo^-1*", +"temperature_min_01","temperature_min_01","WorldClim_2.1_UKESM1-0-LL_ssp585_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jan","min T Jan","january","degrees Celsius","*degree*C*", +"temperature_min_02","temperature_min_02","WorldClim_2.1_UKESM1-0-LL_ssp585_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Feb","min T Feb","february","degrees Celsius","*degree*C*", +"temperature_min_03","temperature_min_03","WorldClim_2.1_UKESM1-0-LL_ssp585_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Mar","min T Mar","march","degrees Celsius","*degree*C*", +"temperature_min_04","temperature_min_04","WorldClim_2.1_UKESM1-0-LL_ssp585_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Apr","min T Apr","april","degrees Celsius","*degree*C*", +"temperature_min_05","temperature_min_05","WorldClim_2.1_UKESM1-0-LL_ssp585_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature May","min T May","may","degrees Celsius","*degree*C*", +"temperature_min_06","temperature_min_06","WorldClim_2.1_UKESM1-0-LL_ssp585_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jun","min T Jun","june","degrees Celsius","*degree*C*", +"temperature_min_07","temperature_min_07","WorldClim_2.1_UKESM1-0-LL_ssp585_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jul","min T Jul","july","degrees Celsius","*degree*C*", +"temperature_min_08","temperature_min_08","WorldClim_2.1_UKESM1-0-LL_ssp585_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Aug","min T Aug","august","degrees Celsius","*degree*C*", +"temperature_min_09","temperature_min_09","WorldClim_2.1_UKESM1-0-LL_ssp585_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Sep","min T Sep","september","degrees Celsius","*degree*C*", +"temperature_min_10","temperature_min_10","WorldClim_2.1_UKESM1-0-LL_ssp585_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Oct","min T Oct","october","degrees Celsius","*degree*C*", +"temperature_min_11","temperature_min_11","WorldClim_2.1_UKESM1-0-LL_ssp585_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Nov","min T Nov","november","degrees Celsius","*degree*C*", +"temperature_min_12","temperature_min_12","WorldClim_2.1_UKESM1-0-LL_ssp585_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp585_10m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Dec","min T Dec","december","degrees Celsius","*degree*C*", +"temperature_max_01","temperature_max_01","WorldClim_2.1_UKESM1-0-LL_ssp585_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jan","max T Jan","january","degrees Celsius","*degree*C*", +"temperature_max_02","temperature_max_02","WorldClim_2.1_UKESM1-0-LL_ssp585_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Feb","max T Feb","february","degrees Celsius","*degree*C*", +"temperature_max_03","temperature_max_03","WorldClim_2.1_UKESM1-0-LL_ssp585_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Mar","max T Mar","march","degrees Celsius","*degree*C*", +"temperature_max_04","temperature_max_04","WorldClim_2.1_UKESM1-0-LL_ssp585_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Apr","max T Apr","april","degrees Celsius","*degree*C*", +"temperature_max_05","temperature_max_05","WorldClim_2.1_UKESM1-0-LL_ssp585_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature May","max T May","may","degrees Celsius","*degree*C*", +"temperature_max_06","temperature_max_06","WorldClim_2.1_UKESM1-0-LL_ssp585_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jun","max T Jun","june","degrees Celsius","*degree*C*", +"temperature_max_07","temperature_max_07","WorldClim_2.1_UKESM1-0-LL_ssp585_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jul","max T Jul","july","degrees Celsius","*degree*C*", +"temperature_max_08","temperature_max_08","WorldClim_2.1_UKESM1-0-LL_ssp585_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Aug","max T Aug","august","degrees Celsius","*degree*C*", +"temperature_max_09","temperature_max_09","WorldClim_2.1_UKESM1-0-LL_ssp585_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Sep","max T Sep","september","degrees Celsius","*degree*C*", +"temperature_max_10","temperature_max_10","WorldClim_2.1_UKESM1-0-LL_ssp585_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Oct","max T Oct","october","degrees Celsius","*degree*C*", +"temperature_max_11","temperature_max_11","WorldClim_2.1_UKESM1-0-LL_ssp585_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Nov","max T Nov","november","degrees Celsius","*degree*C*", +"temperature_max_12","temperature_max_12","WorldClim_2.1_UKESM1-0-LL_ssp585_10m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp585_10m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Dec","max T Dec","december","degrees Celsius","*degree*C*", +"bio01","bio01","WorldClim_2.1_UKESM1-0-LL_ssp585_5m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual mean temperature","ann. mean T","year","degrees Celsius","*degree*C*", +"bio02","bio02","WorldClim_2.1_UKESM1-0-LL_ssp585_5m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean diurnal range","diurn. range","year","degrees Celsius","*degree*C*", +"bio03","bio03","WorldClim_2.1_UKESM1-0-LL_ssp585_5m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","isothermality","isothermality","year","","", +"bio04","bio04","WorldClim_2.1_UKESM1-0-LL_ssp585_5m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature seasonality","T season.","year","degrees Celsius","*degree*C*", +"bio05","bio05","WorldClim_2.1_UKESM1-0-LL_ssp585_5m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature of warmest month","max. T of warmest mo.","year","degrees Celsius","*degree*C*", +"bio06","bio06","WorldClim_2.1_UKESM1-0-LL_ssp585_5m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature of coldest month","min. T of coldest mo.","year","degrees Celsius","*degree*C*", +"bio07","bio07","WorldClim_2.1_UKESM1-0-LL_ssp585_5m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","temperature annual range (bio05-bio06)","T ann. Range","year","degrees Celsius","*degree*C*", +"bio08","bio08","WorldClim_2.1_UKESM1-0-LL_ssp585_5m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of wettest quarter","mean T of wettest qtr","year","degrees Celsius","*degree*C*", +"bio09","bio09","WorldClim_2.1_UKESM1-0-LL_ssp585_5m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of driest quarter","mean T of driest qtr","year","degrees Celsius","*degree*C*", +"bio10","bio10","WorldClim_2.1_UKESM1-0-LL_ssp585_5m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of warmest quarter","mean T of warmest qtr","year","degrees Celsius","*degree*C*", +"bio11","bio11","WorldClim_2.1_UKESM1-0-LL_ssp585_5m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","mean temperature of coldest quarter","mean T of coldest qtr","year","degrees Celsius","*degree*C*", +"bio12","bio12","WorldClim_2.1_UKESM1-0-LL_ssp585_5m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","annual precipitation","ann. P","year","mm per year","*mm~yr^-1*", +"bio13","bio13","WorldClim_2.1_UKESM1-0-LL_ssp585_5m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest month","P of wettest mo.","year","mm per month","*mm~mo^-1*", +"bio14","bio14","WorldClim_2.1_UKESM1-0-LL_ssp585_5m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest month","P of driest mo.","year","mm per month","*mm~mo^-1*", +"bio15","bio15","WorldClim_2.1_UKESM1-0-LL_ssp585_5m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation seasonality (coeff var)","P season.","year","","", +"bio16","bio16","WorldClim_2.1_UKESM1-0-LL_ssp585_5m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of wettest quarter","P of wettest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio17","bio17","WorldClim_2.1_UKESM1-0-LL_ssp585_5m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of driest quarter","P of driest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio18","bio18","WorldClim_2.1_UKESM1-0-LL_ssp585_5m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of warmest quarter","P of warmest qtr","year","mm per quarter","*mm~qtr^-1*", +"bio19","bio19","WorldClim_2.1_UKESM1-0-LL_ssp585_5m",FALSE,"WorldClim_2.1_UKESM1-0-LL_ssp585_5m_bio_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation of coldest quarter","P of coldest qtr","year","mm per quarter","*mm~qtr^-1*", +"precipitation_01","precipitation_01","WorldClim_2.1_UKESM1-0-LL_ssp585_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jan","P Jan","january","mm per month","*mm~mo^-1*", +"precipitation_02","precipitation_02","WorldClim_2.1_UKESM1-0-LL_ssp585_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Feb","P Feb","february","mm per month","*mm~mo^-1*", +"precipitation_03","precipitation_03","WorldClim_2.1_UKESM1-0-LL_ssp585_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Mar","P Mar","march","mm per month","*mm~mo^-1*", +"precipitation_04","precipitation_04","WorldClim_2.1_UKESM1-0-LL_ssp585_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Apr","P Apr","april","mm per month","*mm~mo^-1*", +"precipitation_05","precipitation_05","WorldClim_2.1_UKESM1-0-LL_ssp585_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation May","P May","may","mm per month","*mm~mo^-1*", +"precipitation_06","precipitation_06","WorldClim_2.1_UKESM1-0-LL_ssp585_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jun","P Jun","june","mm per month","*mm~mo^-1*", +"precipitation_07","precipitation_07","WorldClim_2.1_UKESM1-0-LL_ssp585_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Jul","P Jul","july","mm per month","*mm~mo^-1*", +"precipitation_08","precipitation_08","WorldClim_2.1_UKESM1-0-LL_ssp585_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Aug","P Aug","august","mm per month","*mm~mo^-1*", +"precipitation_09","precipitation_09","WorldClim_2.1_UKESM1-0-LL_ssp585_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Sep","P Sep","september","mm per month","*mm~mo^-1*", +"precipitation_10","precipitation_10","WorldClim_2.1_UKESM1-0-LL_ssp585_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Oct","P Oct","october","mm per month","*mm~mo^-1*", +"precipitation_11","precipitation_11","WorldClim_2.1_UKESM1-0-LL_ssp585_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Nov","P Nov","november","mm per month","*mm~mo^-1*", +"precipitation_12","precipitation_12","WorldClim_2.1_UKESM1-0-LL_ssp585_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp585_5m_prec_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","precipitation Dec","P Dec","december","mm per month","*mm~mo^-1*", +"temperature_min_01","temperature_min_01","WorldClim_2.1_UKESM1-0-LL_ssp585_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jan","min T Jan","january","degrees Celsius","*degree*C*", +"temperature_min_02","temperature_min_02","WorldClim_2.1_UKESM1-0-LL_ssp585_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Feb","min T Feb","february","degrees Celsius","*degree*C*", +"temperature_min_03","temperature_min_03","WorldClim_2.1_UKESM1-0-LL_ssp585_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Mar","min T Mar","march","degrees Celsius","*degree*C*", +"temperature_min_04","temperature_min_04","WorldClim_2.1_UKESM1-0-LL_ssp585_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Apr","min T Apr","april","degrees Celsius","*degree*C*", +"temperature_min_05","temperature_min_05","WorldClim_2.1_UKESM1-0-LL_ssp585_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature May","min T May","may","degrees Celsius","*degree*C*", +"temperature_min_06","temperature_min_06","WorldClim_2.1_UKESM1-0-LL_ssp585_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jun","min T Jun","june","degrees Celsius","*degree*C*", +"temperature_min_07","temperature_min_07","WorldClim_2.1_UKESM1-0-LL_ssp585_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Jul","min T Jul","july","degrees Celsius","*degree*C*", +"temperature_min_08","temperature_min_08","WorldClim_2.1_UKESM1-0-LL_ssp585_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Aug","min T Aug","august","degrees Celsius","*degree*C*", +"temperature_min_09","temperature_min_09","WorldClim_2.1_UKESM1-0-LL_ssp585_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Sep","min T Sep","september","degrees Celsius","*degree*C*", +"temperature_min_10","temperature_min_10","WorldClim_2.1_UKESM1-0-LL_ssp585_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Oct","min T Oct","october","degrees Celsius","*degree*C*", +"temperature_min_11","temperature_min_11","WorldClim_2.1_UKESM1-0-LL_ssp585_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Nov","min T Nov","november","degrees Celsius","*degree*C*", +"temperature_min_12","temperature_min_12","WorldClim_2.1_UKESM1-0-LL_ssp585_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp585_5m_tmin_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","minimum temperature Dec","min T Dec","december","degrees Celsius","*degree*C*", +"temperature_max_01","temperature_max_01","WorldClim_2.1_UKESM1-0-LL_ssp585_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jan","max T Jan","january","degrees Celsius","*degree*C*", +"temperature_max_02","temperature_max_02","WorldClim_2.1_UKESM1-0-LL_ssp585_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Feb","max T Feb","february","degrees Celsius","*degree*C*", +"temperature_max_03","temperature_max_03","WorldClim_2.1_UKESM1-0-LL_ssp585_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Mar","max T Mar","march","degrees Celsius","*degree*C*", +"temperature_max_04","temperature_max_04","WorldClim_2.1_UKESM1-0-LL_ssp585_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Apr","max T Apr","april","degrees Celsius","*degree*C*", +"temperature_max_05","temperature_max_05","WorldClim_2.1_UKESM1-0-LL_ssp585_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature May","max T May","may","degrees Celsius","*degree*C*", +"temperature_max_06","temperature_max_06","WorldClim_2.1_UKESM1-0-LL_ssp585_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jun","max T Jun","june","degrees Celsius","*degree*C*", +"temperature_max_07","temperature_max_07","WorldClim_2.1_UKESM1-0-LL_ssp585_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Jul","max T Jul","july","degrees Celsius","*degree*C*", +"temperature_max_08","temperature_max_08","WorldClim_2.1_UKESM1-0-LL_ssp585_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Aug","max T Aug","august","degrees Celsius","*degree*C*", +"temperature_max_09","temperature_max_09","WorldClim_2.1_UKESM1-0-LL_ssp585_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Sep","max T Sep","september","degrees Celsius","*degree*C*", +"temperature_max_10","temperature_max_10","WorldClim_2.1_UKESM1-0-LL_ssp585_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Oct","max T Oct","october","degrees Celsius","*degree*C*", +"temperature_max_11","temperature_max_11","WorldClim_2.1_UKESM1-0-LL_ssp585_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Nov","max T Nov","november","degrees Celsius","*degree*C*", +"temperature_max_12","temperature_max_12","WorldClim_2.1_UKESM1-0-LL_ssp585_5m",TRUE,"WorldClim_2.1_UKESM1-0-LL_ssp585_5m_tmax_v1.4.0.nc",,"download_worldclim_future",,,"1.4.0","maximum temperature Dec","max T Dec","december","degrees Celsius","*degree*C*", diff --git a/data-raw/data_files/worldclim_future_template.csv b/data-raw/data_files/worldclim_future_template.csv new file mode 100644 index 00000000..77564a4c --- /dev/null +++ b/data-raw/data_files/worldclim_future_template.csv @@ -0,0 +1,56 @@ +variable,ncvar,dataset,monthly,file_name,download_path,download_function,file_name_orig,download_path_orig,version,long_name,abbreviated_name,time_frame,units,units_exp,dataset_list_v +bio01,bio01,WorldClim_2.1_XXX_YYY_ZZZm,FALSE,WorldClim_2.1_XXX_YYY_ZZZm_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual mean temperature,ann. mean T,year,degrees Celsius,*degree*C*, +bio02,bio02,WorldClim_2.1_XXX_YYY_ZZZm,FALSE,WorldClim_2.1_XXX_YYY_ZZZm_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean diurnal range,diurn. range,year,degrees Celsius,*degree*C*, +bio03,bio03,WorldClim_2.1_XXX_YYY_ZZZm,FALSE,WorldClim_2.1_XXX_YYY_ZZZm_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,isothermality,isothermality,year,,, +bio04,bio04,WorldClim_2.1_XXX_YYY_ZZZm,FALSE,WorldClim_2.1_XXX_YYY_ZZZm_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature seasonality,T season.,year,degrees Celsius,*degree*C*, +bio05,bio05,WorldClim_2.1_XXX_YYY_ZZZm,FALSE,WorldClim_2.1_XXX_YYY_ZZZm_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature of warmest month,max. T of warmest mo.,year,degrees Celsius,*degree*C*, +bio06,bio06,WorldClim_2.1_XXX_YYY_ZZZm,FALSE,WorldClim_2.1_XXX_YYY_ZZZm_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature of coldest month,min. T of coldest mo.,year,degrees Celsius,*degree*C*, +bio07,bio07,WorldClim_2.1_XXX_YYY_ZZZm,FALSE,WorldClim_2.1_XXX_YYY_ZZZm_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,temperature annual range (bio05-bio06),T ann. Range,year,degrees Celsius,*degree*C*, +bio08,bio08,WorldClim_2.1_XXX_YYY_ZZZm,FALSE,WorldClim_2.1_XXX_YYY_ZZZm_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of wettest quarter,mean T of wettest qtr,year,degrees Celsius,*degree*C*, +bio09,bio09,WorldClim_2.1_XXX_YYY_ZZZm,FALSE,WorldClim_2.1_XXX_YYY_ZZZm_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of driest quarter,mean T of driest qtr,year,degrees Celsius,*degree*C*, +bio10,bio10,WorldClim_2.1_XXX_YYY_ZZZm,FALSE,WorldClim_2.1_XXX_YYY_ZZZm_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of warmest quarter,mean T of warmest qtr,year,degrees Celsius,*degree*C*, +bio11,bio11,WorldClim_2.1_XXX_YYY_ZZZm,FALSE,WorldClim_2.1_XXX_YYY_ZZZm_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,mean temperature of coldest quarter,mean T of coldest qtr,year,degrees Celsius,*degree*C*, +bio12,bio12,WorldClim_2.1_XXX_YYY_ZZZm,FALSE,WorldClim_2.1_XXX_YYY_ZZZm_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,annual precipitation,ann. P,year,mm per year,*mm~yr^-1*, +bio13,bio13,WorldClim_2.1_XXX_YYY_ZZZm,FALSE,WorldClim_2.1_XXX_YYY_ZZZm_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest month,P of wettest mo.,year,mm per month,*mm~mo^-1*, +bio14,bio14,WorldClim_2.1_XXX_YYY_ZZZm,FALSE,WorldClim_2.1_XXX_YYY_ZZZm_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest month,P of driest mo.,year,mm per month,*mm~mo^-1*, +bio15,bio15,WorldClim_2.1_XXX_YYY_ZZZm,FALSE,WorldClim_2.1_XXX_YYY_ZZZm_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation seasonality (coeff var),P season.,year,,, +bio16,bio16,WorldClim_2.1_XXX_YYY_ZZZm,FALSE,WorldClim_2.1_XXX_YYY_ZZZm_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of wettest quarter,P of wettest qtr,year,mm per quarter,*mm~qtr^-1*, +bio17,bio17,WorldClim_2.1_XXX_YYY_ZZZm,FALSE,WorldClim_2.1_XXX_YYY_ZZZm_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of driest quarter,P of driest qtr,year,mm per quarter,*mm~qtr^-1*, +bio18,bio18,WorldClim_2.1_XXX_YYY_ZZZm,FALSE,WorldClim_2.1_XXX_YYY_ZZZm_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of warmest quarter,P of warmest qtr,year,mm per quarter,*mm~qtr^-1*, +bio19,bio19,WorldClim_2.1_XXX_YYY_ZZZm,FALSE,WorldClim_2.1_XXX_YYY_ZZZm_bio_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation of coldest quarter,P of coldest qtr,year,mm per quarter,*mm~qtr^-1*, +precipitation_01,precipitation_01,WorldClim_2.1_XXX_YYY_ZZZm,TRUE,WorldClim_2.1_XXX_YYY_ZZZm_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jan,P Jan,january,mm per month,*mm~mo^-1*, +precipitation_02,precipitation_02,WorldClim_2.1_XXX_YYY_ZZZm,TRUE,WorldClim_2.1_XXX_YYY_ZZZm_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Feb,P Feb,february,mm per month,*mm~mo^-1*, +precipitation_03,precipitation_03,WorldClim_2.1_XXX_YYY_ZZZm,TRUE,WorldClim_2.1_XXX_YYY_ZZZm_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Mar,P Mar,march,mm per month,*mm~mo^-1*, +precipitation_04,precipitation_04,WorldClim_2.1_XXX_YYY_ZZZm,TRUE,WorldClim_2.1_XXX_YYY_ZZZm_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Apr,P Apr,april,mm per month,*mm~mo^-1*, +precipitation_05,precipitation_05,WorldClim_2.1_XXX_YYY_ZZZm,TRUE,WorldClim_2.1_XXX_YYY_ZZZm_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation May,P May,may,mm per month,*mm~mo^-1*, +precipitation_06,precipitation_06,WorldClim_2.1_XXX_YYY_ZZZm,TRUE,WorldClim_2.1_XXX_YYY_ZZZm_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jun,P Jun,june,mm per month,*mm~mo^-1*, +precipitation_07,precipitation_07,WorldClim_2.1_XXX_YYY_ZZZm,TRUE,WorldClim_2.1_XXX_YYY_ZZZm_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Jul,P Jul,july,mm per month,*mm~mo^-1*, +precipitation_08,precipitation_08,WorldClim_2.1_XXX_YYY_ZZZm,TRUE,WorldClim_2.1_XXX_YYY_ZZZm_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Aug,P Aug,august,mm per month,*mm~mo^-1*, +precipitation_09,precipitation_09,WorldClim_2.1_XXX_YYY_ZZZm,TRUE,WorldClim_2.1_XXX_YYY_ZZZm_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Sep,P Sep,september,mm per month,*mm~mo^-1*, +precipitation_10,precipitation_10,WorldClim_2.1_XXX_YYY_ZZZm,TRUE,WorldClim_2.1_XXX_YYY_ZZZm_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Oct,P Oct,october,mm per month,*mm~mo^-1*, +precipitation_11,precipitation_11,WorldClim_2.1_XXX_YYY_ZZZm,TRUE,WorldClim_2.1_XXX_YYY_ZZZm_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Nov,P Nov,november,mm per month,*mm~mo^-1*, +precipitation_12,precipitation_12,WorldClim_2.1_XXX_YYY_ZZZm,TRUE,WorldClim_2.1_XXX_YYY_ZZZm_prec_v1.4.0.nc,,download_worldclim_future,,,1.4.0,precipitation Dec,P Dec,december,mm per month,*mm~mo^-1*, +temperature_min_01,temperature_min_01,WorldClim_2.1_XXX_YYY_ZZZm,TRUE,WorldClim_2.1_XXX_YYY_ZZZm_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jan,min T Jan,january,degrees Celsius,*degree*C*, +temperature_min_02,temperature_min_02,WorldClim_2.1_XXX_YYY_ZZZm,TRUE,WorldClim_2.1_XXX_YYY_ZZZm_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Feb,min T Feb,february,degrees Celsius,*degree*C*, +temperature_min_03,temperature_min_03,WorldClim_2.1_XXX_YYY_ZZZm,TRUE,WorldClim_2.1_XXX_YYY_ZZZm_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Mar,min T Mar,march,degrees Celsius,*degree*C*, +temperature_min_04,temperature_min_04,WorldClim_2.1_XXX_YYY_ZZZm,TRUE,WorldClim_2.1_XXX_YYY_ZZZm_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Apr,min T Apr,april,degrees Celsius,*degree*C*, +temperature_min_05,temperature_min_05,WorldClim_2.1_XXX_YYY_ZZZm,TRUE,WorldClim_2.1_XXX_YYY_ZZZm_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature May,min T May,may,degrees Celsius,*degree*C*, +temperature_min_06,temperature_min_06,WorldClim_2.1_XXX_YYY_ZZZm,TRUE,WorldClim_2.1_XXX_YYY_ZZZm_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jun,min T Jun,june,degrees Celsius,*degree*C*, +temperature_min_07,temperature_min_07,WorldClim_2.1_XXX_YYY_ZZZm,TRUE,WorldClim_2.1_XXX_YYY_ZZZm_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Jul,min T Jul,july,degrees Celsius,*degree*C*, +temperature_min_08,temperature_min_08,WorldClim_2.1_XXX_YYY_ZZZm,TRUE,WorldClim_2.1_XXX_YYY_ZZZm_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Aug,min T Aug,august,degrees Celsius,*degree*C*, +temperature_min_09,temperature_min_09,WorldClim_2.1_XXX_YYY_ZZZm,TRUE,WorldClim_2.1_XXX_YYY_ZZZm_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Sep,min T Sep,september,degrees Celsius,*degree*C*, +temperature_min_10,temperature_min_10,WorldClim_2.1_XXX_YYY_ZZZm,TRUE,WorldClim_2.1_XXX_YYY_ZZZm_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Oct,min T Oct,october,degrees Celsius,*degree*C*, +temperature_min_11,temperature_min_11,WorldClim_2.1_XXX_YYY_ZZZm,TRUE,WorldClim_2.1_XXX_YYY_ZZZm_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Nov,min T Nov,november,degrees Celsius,*degree*C*, +temperature_min_12,temperature_min_12,WorldClim_2.1_XXX_YYY_ZZZm,TRUE,WorldClim_2.1_XXX_YYY_ZZZm_tmin_v1.4.0.nc,,download_worldclim_future,,,1.4.0,minimum temperature Dec,min T Dec,december,degrees Celsius,*degree*C*, +temperature_max_01,temperature_max_01,WorldClim_2.1_XXX_YYY_ZZZm,TRUE,WorldClim_2.1_XXX_YYY_ZZZm_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jan,max T Jan,january,degrees Celsius,*degree*C*, +temperature_max_02,temperature_max_02,WorldClim_2.1_XXX_YYY_ZZZm,TRUE,WorldClim_2.1_XXX_YYY_ZZZm_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Feb,max T Feb,february,degrees Celsius,*degree*C*, +temperature_max_03,temperature_max_03,WorldClim_2.1_XXX_YYY_ZZZm,TRUE,WorldClim_2.1_XXX_YYY_ZZZm_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Mar,max T Mar,march,degrees Celsius,*degree*C*, +temperature_max_04,temperature_max_04,WorldClim_2.1_XXX_YYY_ZZZm,TRUE,WorldClim_2.1_XXX_YYY_ZZZm_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Apr,max T Apr,april,degrees Celsius,*degree*C*, +temperature_max_05,temperature_max_05,WorldClim_2.1_XXX_YYY_ZZZm,TRUE,WorldClim_2.1_XXX_YYY_ZZZm_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature May,max T May,may,degrees Celsius,*degree*C*, +temperature_max_06,temperature_max_06,WorldClim_2.1_XXX_YYY_ZZZm,TRUE,WorldClim_2.1_XXX_YYY_ZZZm_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jun,max T Jun,june,degrees Celsius,*degree*C*, +temperature_max_07,temperature_max_07,WorldClim_2.1_XXX_YYY_ZZZm,TRUE,WorldClim_2.1_XXX_YYY_ZZZm_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Jul,max T Jul,july,degrees Celsius,*degree*C*, +temperature_max_08,temperature_max_08,WorldClim_2.1_XXX_YYY_ZZZm,TRUE,WorldClim_2.1_XXX_YYY_ZZZm_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Aug,max T Aug,august,degrees Celsius,*degree*C*, +temperature_max_09,temperature_max_09,WorldClim_2.1_XXX_YYY_ZZZm,TRUE,WorldClim_2.1_XXX_YYY_ZZZm_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Sep,max T Sep,september,degrees Celsius,*degree*C*, +temperature_max_10,temperature_max_10,WorldClim_2.1_XXX_YYY_ZZZm,TRUE,WorldClim_2.1_XXX_YYY_ZZZm_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Oct,max T Oct,october,degrees Celsius,*degree*C*, +temperature_max_11,temperature_max_11,WorldClim_2.1_XXX_YYY_ZZZm,TRUE,WorldClim_2.1_XXX_YYY_ZZZm_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Nov,max T Nov,november,degrees Celsius,*degree*C*, +temperature_max_12,temperature_max_12,WorldClim_2.1_XXX_YYY_ZZZm,TRUE,WorldClim_2.1_XXX_YYY_ZZZm_tmax_v1.4.0.nc,,download_worldclim_future,,,1.4.0,maximum temperature Dec,max T Dec,december,degrees Celsius,*degree*C*, diff --git a/data-raw/dataset_list_included.R b/data-raw/dataset_list_included.R deleted file mode 100644 index f7be16e7..00000000 --- a/data-raw/dataset_list_included.R +++ /dev/null @@ -1,7 +0,0 @@ -## code to prepare `dataset_list_included` dataset -## set wkdir to this file, and source this script in RStudio -# or run from within the data-raw directory -dataset_list_included <- - read.csv("../inst/extdata/dataset_list_included.csv") -dataset_list_included$dataset <- as.factor(dataset_list_included$dataset) -usethis::use_data(dataset_list_included, internal = TRUE, overwrite = TRUE) diff --git a/data-raw/format_climate_datasets/test_bio_vars.R b/data-raw/format_climate_datasets/test_bio_vars.R new file mode 100644 index 00000000..982117ef --- /dev/null +++ b/data-raw/format_climate_datasets/test_bio_vars.R @@ -0,0 +1,100 @@ +# monthly_vars <- c(paste0("temperature_",sprintf("%02d", 1:12)), +# paste0("precipitation_",sprintf("%02d", 1:12))) +# pastclim:::download_dataset(dataset = "Krapp2021",bio_variables = monthly_vars) + +setwd("~/Downloads/data/processed/") + +krapp_new <- terra::rast(dir("./")) + + +krapp_temp <- pastclim::region_slice( + time_bp = 0, + dataset = "Krapp2021", + bio_variables = paste0("temperature_", sprintf("%02d", 1:12)) +) +krapp_temp <- krapp_temp - 273.15 + +krapp_prec <- pastclim::region_slice( + time_bp = 0, + dataset = "Krapp2021", + bio_variables = paste0("precipitation_", sprintf("%02d", 1:12)) +) +krapp_biovar <- pastclim::bioclim_vars(prec = krapp_prec, tavg = krapp_temp) + +krapp_pastclim_biovar <- pastclim::region_slice( + time_bp = 0, + dataset = "Krapp2021", + bio_variables = names(krapp_biovar) +) + + +cor_all <- vector() +for (i in names(krapp_biovar)) { + cor_all[i] <- cor.test( + as.matrix(krapp_biovar[[i]]), + as.matrix(krapp_new[[i]]) + )$estimate +} +cor_all + +krapp_new[101, 150] +krapp_biovar[101, 150] +krapp_prec[101, 150] + +# bio07, bio15 + +# bio12, bio13, bio14,bio16,bio17,bio18,bio19 + +# bio12 should not be divided by 12 (it should be the sum) +# bio13, bio14, bio16, bio17,bio18,and bio19 are divided by 12 + +# find discrepancies +# bio05 +krapp_pastclim_biovar$bio10[101, 150] +krapp_biovar$bio10[101, 150] + + +krapp_temp[100, 150] + +# check that monhtly temperature make sense +this_temp <- ncdf4::nc_open("bio19_800ka.nc") +sep_temp <- ncdf4::ncvar_get(nc = this_temp, varid = "bio19") +sep_temp[, , 800] -> foo +foo[foo > 10^10] <- NA +image(foo) +foo <- foo[, ncol(foo):1] +foo <- terra::rast(t(foo)) +plot(foo) +foo[101, 150] + + + +# bio15 is seasonality. In Mario's formula, the +1 is only applied to the sum, but not the + +this_prec <- unlist(krapp_prec[101, 150]) +100 * sd(this_prec) / ((sum(this_prec) + 1) / 12) + + + +## Unit issues +# bio04 in Krapp not multiplied by 100 (but maybe somethign else) +# bio12 in Krapp is the mean of the precipitation (not the total annual precipitation) +# bio16 and bio17 is the sum of the precipitation in that quarter, not the monthly mean + +## inconsistencies +# bio05, bio06, bio07 are different as they are based on monthly temperatures using the pastclim function, +# but on monthly temperatures when using the downscaling functions. Depsite bio05 and bio06 being well correlated, +# bio07 (their difference) is not. However, bio05 and bio06 are less extreme than the monthly average, which does not make sense. + +# bio15 + +## Variable duplication +# bio08 is copy of bio10, +# bio09 is copy of bio 11 +# bio18 is a copy of bio16 +# bio19 is a copy of bio17 + +cor.test( + as.matrix(krapp_pastclim_biovar$bio16), + as.matrix(krapp_pastclim_biovar$bio18) +)$estimate diff --git a/data-raw/format_climate_datasets/test_bio_vars_beyer.R b/data-raw/format_climate_datasets/test_bio_vars_beyer.R new file mode 100644 index 00000000..9401601c --- /dev/null +++ b/data-raw/format_climate_datasets/test_bio_vars_beyer.R @@ -0,0 +1,92 @@ +# monthly_vars <- c(paste0("temperature_",sprintf("%02d", 1:12)), +# paste0("precipitation_",sprintf("%02d", 1:12))) +# pastclim:::download_dataset(dataset = "beyer2021",bio_variables = monthly_vars) + + +beyer_temp <- pastclim::region_slice( + time_bp = 0, + dataset = "Beyer2020", + bio_variables = paste0("temperature_", sprintf("%02d", 1:12)) +) +# beyer_temp <- beyer_temp - 273.15 + +beyer_prec <- pastclim::region_slice( + time_bp = 0, + dataset = "Beyer2020", + bio_variables = paste0("precipitation_", sprintf("%02d", 1:12)) +) +beyer_biovar <- pastclim::bioclim_vars(prec = beyer_prec, tavg = beyer_temp) + +beyer_pastclim_biovar <- pastclim::region_slice( + time_bp = 0, + dataset = "Beyer2020", + bio_variables = names(beyer_biovar) +) + + +cor_all <- vector() +for (i in names(beyer_biovar)) { + cor_all[i] <- cor.test( + as.matrix(beyer_biovar[[i]]), + as.matrix(beyer_pastclim_biovar[[i]]) + )$estimate +} +cor_all + + +# bio07, bio15 + +# bio12, bio13, bio14,bio16,bio17,bio18,bio19 + +# bio12 should not be divided by 12 (it should be the sum) +# bio13, bio14, bio16, bio17,bio18,and bio19 are divided by 12 + +# find discrepancies +# bio05 +beyer_pastclim_biovar[101, 150] +beyer_biovar[101, 150] + +beyer_temp[100, 150] + +# check that monhtly temperature make sense +this_temp <- ncdf4::nc_open("bio19_800ka.nc") +sep_temp <- ncdf4::ncvar_get(nc = this_temp, varid = "bio19") +sep_temp[, , 800] -> foo +foo[foo > 10^10] <- NA +image(foo) +foo <- foo[, ncol(foo):1] +foo <- terra::rast(t(foo)) +plot(foo) +foo[101, 150] + + + +# bio15 is seasonality. In Mario's formula, the +1 is only applied to the sum, but not the + +this_prec <- unlist(beyer_prec[101, 150]) +100 * sd(this_prec) / ((sum(this_prec) + 1) / 12) + + + +## Unit issues +# bio04 in beyer not multiplied by 100 (but maybe somethign else) +# bio12 in beyer is the mean of the precipitation (not the total annual precipitation) +# bio16 and bio17 is the sum of the precipitation in that quarter, not the monthly mean + +## inconsistencies +# bio05, bio06, bio07 are different as they are based on monthly temperatures using the pastclim function, +# but on monthly temperatures when using the downscaling functions. Depsite bio05 and bio06 being well correlated, +# bio07 (their difference) is not. However, bio05 and bio06 are less extreme than the monthly average, which does not make sense. + +# bio15 + +## Variable duplication +# bio08 is copy of bio10, +# bio09 is copy of bio 11 +# bio18 is a copy of bio16 +# bio19 is a copy of bio17 + +cor.test( + as.matrix(beyer_pastclim_biovar$bio16), + as.matrix(beyer_pastclim_biovar$bio18) +)$estimate diff --git a/data-raw/format_climate_datasets/test_bio_vars_new_krapp.R b/data-raw/format_climate_datasets/test_bio_vars_new_krapp.R new file mode 100644 index 00000000..67e1577c --- /dev/null +++ b/data-raw/format_climate_datasets/test_bio_vars_new_krapp.R @@ -0,0 +1,101 @@ +# monthly_vars <- c(paste0("temperature_",sprintf("%02d", 1:12)), +# paste0("precipitation_",sprintf("%02d", 1:12))) +# pastclim:::download_dataset(dataset = "Krapp2021",bio_variables = monthly_vars) + +# setwd("~/Downloads/data/processed/") + +pastclim::set_data_path(path_to_nc = "~/project_temp/mario_data/", copy_example = FALSE) + + +# krapp_new <- terra::rast(dir("./")) + + +krapp_temp <- pastclim::region_slice( + time_bp = 0, + dataset = "Krapp2021", + bio_variables = paste0("temperature_", sprintf("%02d", 1:12)) +) +krapp_prec <- pastclim::region_slice( + time_bp = 0, + dataset = "Krapp2021", + bio_variables = paste0("precipitation_", sprintf("%02d", 1:12)) +) +krapp_biovar <- pastclim::bioclim_vars(prec = krapp_prec, tavg = krapp_temp) + +krapp_pastclim_biovar <- pastclim::region_slice( + time_bp = 0, + dataset = "Krapp2021", + bio_variables = names(krapp_biovar) +) + + +cor_all <- vector() +for (i in names(krapp_biovar)) { + cor_all[i] <- cor.test( + as.matrix(krapp_biovar[[i]]), + as.matrix(krapp_pastclim_biovar[[i]]) + )$estimate +} +cor_all + +krapp_pastclim_biovar[101, 150] +krapp_biovar[101, 150] +krapp_prec[101, 150] + +# bio07, bio15 + +# bio12, bio13, bio14,bio16,bio17,bio18,bio19 + +# bio12 should not be divided by 12 (it should be the sum) +# bio13, bio14, bio16, bio17,bio18,and bio19 are divided by 12 + +# find discrepancies +# bio05 +krapp_pastclim_biovar$bio10[101, 150] +krapp_biovar$bio10[101, 150] + + +krapp_temp[100, 150] + +# check that monhtly temperature make sense +this_temp <- ncdf4::nc_open("bio19_800ka.nc") +sep_temp <- ncdf4::ncvar_get(nc = this_temp, varid = "bio19") +sep_temp[, , 800] -> foo +foo[foo > 10^10] <- NA +image(foo) +foo <- foo[, ncol(foo):1] +foo <- terra::rast(t(foo)) +plot(foo) +foo[101, 150] + + + +# bio15 is seasonality. In Mario's formula, the +1 is only applied to the sum, but not the + +this_prec <- unlist(krapp_prec[101, 150]) +100 * sd(this_prec) / ((sum(this_prec) + 1) / 12) + + + +## Unit issues +# bio04 in Krapp not multiplied by 100 (but maybe somethign else) +# bio12 in Krapp is the mean of the precipitation (not the total annual precipitation) +# bio16 and bio17 is the sum of the precipitation in that quarter, not the monthly mean + +## inconsistencies +# bio05, bio06, bio07 are different as they are based on monthly temperatures using the pastclim function, +# but on monthly temperatures when using the downscaling functions. Depsite bio05 and bio06 being well correlated, +# bio07 (their difference) is not. However, bio05 and bio06 are less extreme than the monthly average, which does not make sense. + +# bio15 + +## Variable duplication +# bio08 is copy of bio10, +# bio09 is copy of bio 11 +# bio18 is a copy of bio16 +# bio19 is a copy of bio17 + +cor.test( + as.matrix(krapp_pastclim_biovar$bio16), + as.matrix(krapp_pastclim_biovar$bio18) +)$estimate diff --git a/data-raw/helper_functions/check_returns_in_documentation.R b/data-raw/helper_functions/check_returns_in_documentation.R index 0578d76a..5e8fb2d2 100644 --- a/data-raw/helper_functions/check_returns_in_documentation.R +++ b/data-raw/helper_functions/check_returns_in_documentation.R @@ -4,13 +4,56 @@ ## running: grep -Ril -F "\value" ./man/ -check_returns_in_documentation <-function(){ - # note the additiona \ to run through system 2 - files_with_value <- basename(system2(command = "grep", - args=c("-Ril -F ", shQuote("\\value"), " ./man/"), - stdout=TRUE) - ) - all_files<-dir ("./man") - return(all_files[!all_files %in% files_with_value]) +check_returns_in_documentation <- function() { + # get a list of all files in the man directory + all_files <- dir("./man") + + ## there are a number of files that we don't expect to have @returns: + + ## documentation of external dataset; these don't have a usage tag + # functions and internal data have usage + files_with_usage <- basename(system2( + command = "grep", + args = c("-Ril -F ", shQuote("\\usage"), " ./man/"), + stdout = TRUE + )) + # but documentation of external datasets do not + external_data <- all_files[!all_files %in% files_with_usage] + # the above also catches any subdirectories that are accidentally listed + + ## internal data are of Type data + internal_data <- basename(system2( + command = "grep", + args = c("-Ril -F ", shQuote("\\docType{data}"), " ./man/"), + stdout = TRUE + )) + ## the package documentation + package_docs <- basename(system2( + command = "grep", + args = c("-Ril -F ", shQuote("\\docType{package}"), " ./man/"), + stdout = TRUE + )) + excluded_files <- c(internal_data, external_data, package_docs) + ## now remove those files from our list + all_files <- all_files[!all_files %in% excluded_files] + + # get a list of documentation Rd files with \value, as generated by @returns + # note the additional \ to run through system 2 + files_with_value <- basename(system2( + command = "grep", + args = c("-Ril -F ", shQuote("\\value"), " ./man/"), + stdout = TRUE + )) + # and finally check if there is any stray file left + files_missing_returns <- all_files[!all_files %in% files_with_value] + + if (length(files_missing_returns) != 0) { + stop(paste( + "There are some files that miss @return:\n", + paste(files_missing_returns, collapse = ", ") + )) + } else { + return("Success") + } } check_returns_in_documentation() diff --git a/data-raw/helper_functions/submitting_to_cran.R b/data-raw/helper_functions/submitting_to_cran.R index dae04333..313f26c5 100644 --- a/data-raw/helper_functions/submitting_to_cran.R +++ b/data-raw/helper_functions/submitting_to_cran.R @@ -1,6 +1,6 @@ # to this in the dev branch to make sure that all the fundamental issues have been resolved # run the spell checking -usethis::use_spell_check(lang="en-GB") +usethis::use_spell_check(lang = "en-GB") # check the links urlchecker::url_check() diff --git a/data-raw/helper_functions/verify_completeness_of_variables.R b/data-raw/helper_functions/verify_completeness_of_variables.R index bc80a64b..4589533b 100644 --- a/data-raw/helper_functions/verify_completeness_of_variables.R +++ b/data-raw/helper_functions/verify_completeness_of_variables.R @@ -1,10 +1,11 @@ # this script check that we have values for the same cells across all variables dataset <- "Krapp2021" library(pastclim) -download_dataset(dataset=dataset) +download_dataset(dataset = dataset) this_path <- pastclim::get_data_path() vars_for_dataset <- pastclim:::get_file_for_dataset( - get_vars_for_dataset(dataset), dataset) + get_vars_for_dataset(dataset, monthly = TRUE), dataset +) file1 <- ncdf4::nc_open(paste0(this_path, "/", vars_for_dataset$file_name[1])) n_steps <- file1$dim$time$len @@ -32,15 +33,13 @@ n_uniques <- function(x) { apply(n_nas, 2, n_uniques) # check time vars -time_steps<-get_time_steps("custom",paste0(this_path, "/", vars_for_dataset$file_name[1])) +time_steps <- get_time_bp_steps("custom", paste0(this_path, "/", vars_for_dataset$file_name[1])) # check that the time steps are what we expect time_steps # and now check that all files have the same steps -for (i in seq.int(from=2, to=nrow(vars_for_dataset))) { - time_steps_2<-get_time_steps("custom",paste0(this_path, "/", vars_for_dataset$file_name[i])) - if(!all(time_steps==time_steps_2)){ +for (i in seq.int(from = 2, to = nrow(vars_for_dataset))) { + time_steps_2 <- get_time_bp_steps("custom", paste0(this_path, "/", vars_for_dataset$file_name[i])) + if (!all(time_steps == time_steps_2)) { stop("file ", i, "is problematic") } } - - \ No newline at end of file diff --git a/data-raw/helper_functions/verify_files_by_dataset.R b/data-raw/helper_functions/verify_files_by_dataset.R index cbf753b1..c700b302 100644 --- a/data-raw/helper_functions/verify_files_by_dataset.R +++ b/data-raw/helper_functions/verify_files_by_dataset.R @@ -1,13 +1,27 @@ # verify that all the variables in the tables are actually found in the files # this requires all data to have been downloaded -full_meta <- read.csv("./inst/rawdata_scripts/data_files/variable_table.csv") +library(pastclim) +full_meta <- pastclim:::dataset_list_included in_dir <- get_data_path() -in_dir <- "~/project_temp/past_climate/new_meta" -for (i in 1:nrow(full_meta)){ +problem_rows <- vector() +for (i in 1:nrow(full_meta)) { + pastclim::download_dataset( + dataset = as.character(full_meta$dataset[i]), + bio_variables = full_meta$variable[i] + ) nc_in <- ncdf4::nc_open(file.path(in_dir, full_meta$file_name[i])) - if (!full_meta$ncvar[i] %in% names(nc_in$var)){ - ncdf4::nc_close(nc_in) - stop("problem with ",full_meta$ncvar[i]," in ", full_meta$file_name[i]) + if (!full_meta$ncvar[i] %in% names(nc_in$var)) { + message("problem with ", full_meta$ncvar[i], " in ", full_meta$file_name[i], "\n") + stop("we had a problem") + problem_rows[i] <- TRUE + } else { + problem_rows[i] <- FALSE } ncdf4::nc_close(nc_in) } + +if (any(problem_rows)) { + which(problem_rows) +} else { + cat("all files are fine") +} diff --git a/data-raw/make_data/dataset_list_included.R b/data-raw/make_data/dataset_list_included.R new file mode 100644 index 00000000..081fed2a --- /dev/null +++ b/data-raw/make_data/dataset_list_included.R @@ -0,0 +1,7 @@ +## code to prepare `dataset_list_included` dataset +## set wkdir to the directory of this script, and source this script in RStudio +# or run from within the data-raw/make_data directory +dataset_list_included <- + read.csv("../data_files/dataset_list_included.csv") +dataset_list_included$dataset <- as.factor(dataset_list_included$dataset) +usethis::use_data(dataset_list_included, internal = TRUE, overwrite = TRUE) diff --git a/data-raw/make_data/mis_boundaries.R b/data-raw/make_data/mis_boundaries.R new file mode 100644 index 00000000..ee9a3382 --- /dev/null +++ b/data-raw/make_data/mis_boundaries.R @@ -0,0 +1,14 @@ +## code to prepare `mis_boundaries` dataset +## source this script in RStudio +mis_boundaries <- data.frame( + mis = c(20:6, "5e", "5d", "5c", "5b", "5a", 4:1), + start = -1 * c( + 814, 790, 761, 712, 676, 621, 563, 533, 478, 424, 374, 337, + 300, 243, 191, 133, 116, 104, 94, 85, 71, 57, 29, 14 + ), + end = -1 * c( + 790, 761, 712, 676, 621, 563, 533, 478, 424, 374, 337, 300, + 243, 191, 133, 116, 104, 94, 85, 71, 57, 29, 14, 0 + ) +) +usethis::use_data(mis_boundaries, overwrite = TRUE) diff --git a/data-raw/region_extent.R b/data-raw/make_data/region_extent.R similarity index 100% rename from data-raw/region_extent.R rename to data-raw/make_data/region_extent.R diff --git a/data-raw/region_outlines.R b/data-raw/make_data/region_outlines.R similarity index 71% rename from data-raw/region_outlines.R rename to data-raw/make_data/region_outlines.R index 6315c7f6..b7f37af6 100644 --- a/data-raw/region_outlines.R +++ b/data-raw/make_data/region_outlines.R @@ -1,7 +1,8 @@ library(sf) library(terra) outlines <- read.csv("./data_files/continent_outlines.csv", - stringsAsFactors = TRUE) + stringsAsFactors = TRUE +) outlines["X"] <- round(outlines["X"], 2) outlines["Y"] <- round(outlines["Y"], 2) # remove Antarctica, for with the coordinates are problematic as they cross @@ -15,28 +16,30 @@ for (i in 1:nlevels(outlines$id)) { this_coords <- as.matrix(this_outline[, c("X", "Y")]) outlines_df$geometry[i] <- sf::st_sfc(sf::st_polygon(list(this_coords))) } -europe<-data.frame(name="Europe", geometry = "POLYGON ((60 32.58, 33.79 32.58, 32.45 34.02, -30.47 35.15, 28.93 35.65, 27.19 34.88, 24.84 34.02, 22.93 34.43, 21.99 35.73, -16.16 36.25, 14.25 35.21, 13.14 36.06, 11.97 37.46, 11.13 38.1, 9.32 38.49, -7.91 38.2, 6.67 40.08, 3.69 38.81, 1.58 37.88, -0.50 36.95, -1.61 36.38, +europe <- data.frame(name = "Europe", geometry = "POLYGON ((60 32.58, 33.79 32.58, 32.45 34.02, +30.47 35.15, 28.93 35.65, 27.19 34.88, 24.84 34.02, 22.93 34.43, 21.99 35.73, +16.16 36.25, 14.25 35.21, 13.14 36.06, 11.97 37.46, 11.13 38.1, 9.32 38.49, +7.91 38.2, 6.67 40.08, 3.69 38.81, 1.58 37.88, -0.50 36.95, -1.61 36.38, -3.05 36, -4.29 35.92, -6.93 35.95, -9.08 36.41, -11.29 38.02, -11.06 41.41, --9.88 44.27, -8.44 46.9, -6.63 48.4, -8.01 49.54, -9.72 50.64, -12.40 51.36, --15.21 55.45, -25.00 62.07, -27.15 66.09, -22.45 67.46, -16.82 68.47, --9.58 69.22, -9.65 72.43, -0.80 77.05, 13.68 80.95, 34.59 81.68, 60 81.68, +-9.88 44.27, -8.44 46.9, -6.63 48.4, -8.01 49.54, -9.72 50.64, -12.40 51.36, +-15.21 55.45, -25.00 62.07, -27.15 66.09, -22.45 67.46, -16.82 68.47, +-9.58 69.22, -9.65 72.43, -0.80 77.05, 13.68 80.95, 34.59 81.68, 60 81.68, 60 32.58 ))") -europe <- sf::st_as_sf(europe, wkt="geometry") +europe <- sf::st_as_sf(europe, wkt = "geometry") outlines_df <- rbind(outlines_df, europe) outlines_df <- sf::st_sf(outlines_df, sf_column_name = "geometry", crs = "+proj=longlat +datum=WGS84 +ellps=WGS84 +towgs84=0,0,0" ) region_outline_union <- outlines_df -region_outline_union<-as.list(outlines_df$geometry) -names(region_outline_union)<-outlines_df$name +region_outline_union <- as.list(outlines_df$geometry) +names(region_outline_union) <- outlines_df$name usethis::use_data(region_outline_union, overwrite = TRUE) # wrap_around_the antimeridian -outlines_df <- sf::st_wrap_dateline(outlines_df, options = c("WRAPDATELINE=YES", - "DATELINEOFFSET=180")) -region_outline<-as.list(outlines_df$geometry) -names(region_outline)<-outlines_df$name +outlines_df <- sf::st_wrap_dateline(outlines_df, options = c( + "WRAPDATELINE=YES", + "DATELINEOFFSET=180" +)) +region_outline <- as.list(outlines_df$geometry) +names(region_outline) <- outlines_df$name usethis::use_data(region_outline, overwrite = TRUE) diff --git a/data-raw/make_extdata/internal_seas.R b/data-raw/make_extdata/internal_seas.R new file mode 100644 index 00000000..b4d369c5 --- /dev/null +++ b/data-raw/make_extdata/internal_seas.R @@ -0,0 +1,12 @@ +# this requires to have unpacked the shapefiles, which are in a zip file in +# /data-raw/data_files/shapefiles_internal_seas.zip + +# TODO it should save the internal_seas.RDS into the extdata folder + +library(terra) +azov <- terra::vect("azov_sea.shp") +black <- terra::vect("black_sea.shp") +caspian <- terra::vect("Caspian_sea.shp") +internal_seas <- rbind(azov, black, caspian) +internal_seas_wrap <- terra::wrap(internal_seas) +saveRDS(internal_seas_wrap, "internal_seas.RDS") diff --git a/data-raw/make_extdata/make_dataset_list_for_wc_future.R b/data-raw/make_extdata/make_dataset_list_for_wc_future.R new file mode 100644 index 00000000..3cde4f30 --- /dev/null +++ b/data-raw/make_extdata/make_dataset_list_for_wc_future.R @@ -0,0 +1,39 @@ +# start this script from this directory +wc_template <- read.csv("../data_files/worldclim_future_template.csv") +gcm <- c( + "ACCESS-CM2", "BCC-CSM2-MR", "CMCC-ESM2", "EC-Earth3-Veg", "FIO-ESM-2-0", + "GFDL-ESM4", "GISS-E2-1-G", "HadGEM3-GC31-LL", "INM-CM5-0", "IPSL-CM6A-LR", + "MIROC6", "MPI-ESM1-2-HR", "MRI-ESM2-0", "UKESM1-0-LL" +) +scenarios <- c("ssp126", "ssp245", "ssp370", "ssp585") +dates_df <- data.frame( + orig = c("2021-2040", "2041-2060", "2061-2080", "2081-2100"), + time_bp = (c(2030, 2050, 2070, 2090) - 1950) +) +resolutions <- c(10, 5) # add 2.5 and 0.5 +library(dplyr) +library(stringr) +wc_future <- wc_template[0, ] +for (i_gcm in gcm) { + for (i_scenario in scenarios) { + for (i_res in resolutions) { + wc_this <- wc_template %>% + mutate( + dataset = str_replace(dataset, "XXX", i_gcm), + file_name = str_replace(file_name, "XXX", i_gcm) + ) %>% + mutate( + dataset = str_replace(dataset, "YYY", i_scenario), + file_name = str_replace(file_name, "YYY", i_scenario) + ) %>% + mutate( + dataset = str_replace(dataset, "ZZZ", as.character(i_res)), + file_name = str_replace(file_name, "ZZZ", as.character(i_res)) + ) + wc_future <- wc_future %>% bind_rows(wc_this) + } + } +} +write.csv(wc_future, "../data_files/worldclim_future_list.csv", + row.names = FALSE, na = "" +) diff --git a/data-raw/mis_boundaries.R b/data-raw/mis_boundaries.R deleted file mode 100644 index b2c8b0a5..00000000 --- a/data-raw/mis_boundaries.R +++ /dev/null @@ -1,10 +0,0 @@ -## code to prepare `mis_boundaries` dataset -## source this script in RStudio -mis_boundaries <- data.frame( - mis = c(20:6, "5e", "5d", "5c", "5b", "5a", 4:1), - start = -1 * c(814, 790, 761, 712, 676, 621, 563, 533, 478, 424, 374, 337, - 300, 243, 191, 133, 116, 104, 94, 85, 71, 57, 29, 14), - end = -1 * c(790, 761, 712, 676, 621, 563, 533, 478, 424, 374, 337, 300, - 243, 191, 133, 116, 104, 94, 85, 71, 57, 29, 14, 0) -) -usethis::use_data(mis_boundaries, overwrite = TRUE) diff --git a/data-raw/readme.md b/data-raw/readme.md index 2e80ba69..3580aa24 100644 --- a/data-raw/readme.md +++ b/data-raw/readme.md @@ -1,6 +1,6 @@ This file provides an overview of the scripts used to generate the data used in pastclim. All R scripts assume that you are in the root directory of the package. -## scripts to create datasets for pastclim (accessible with data()) +## scripts to make data for pastclim (accessible with data()) 1. `dataset_list_included.R` is a script to update the internal dataframe which stores the link between variable names and file names and locations. It is based on `./data_files/dataset_list_included.csv`. @@ -10,6 +10,11 @@ This file provides an overview of the scripts used to generate the data used in 4. `region_outlines.R` create outlines for regions. +## scripts to make extdata for pastclim (stored in inst/extdata) + +1. `internal_seas` combines the .shp of the internal seas into an RDS object. + + ## helpful scripts (this should be turned into tests) - stored under ./helper_functions/ 1. `verify_completeness_of_variables.R` this script is used to check that all @@ -23,7 +28,7 @@ NOTE: these scripts were used with terra <1.6-41, which changed the way time is coded. Make sure that you check the scripts before running, as they might not function as expected. Scripts yet to be updated/checked have been moved to "to_update". -## scripts to package the climate data into nc files +## scripts to package the climate time series into nc files (old, these are being rewritten to clean up) 1. `create_internal_seas_raster.R` generates a mask for internal seas (Caspian and Black sea) which are not removed in some reconstructions. We use a fix outline over time, as there are no good reconstructions through time of their depth levels. Based on `shapefiles_internal_seas.zip` This is used when editing the `beyer2020` dataset. diff --git a/data-raw/to_update/create_example_dataset.R b/data-raw/to_update/create_example_dataset.R index 18213ed9..8c28de5f 100644 --- a/data-raw/to_update/create_example_dataset.R +++ b/data-raw/to_update/create_example_dataset.R @@ -1,18 +1,25 @@ +# This script generates the example dataset, extracting data from Beyer2020 for +# only a few time steps, and upscaling to 1 degree to reduce the file size + +# TO UPDATE MANUALLY file_version <- "1.3.0" -file_name<-paste0("example_climate_v", file_version,".nc") + +# everything else works automatically + +# generate the file name based on the version name +file_name <- paste0("example_climate_v", file_version, ".nc") setwd(tempdir()) library(ClimateOperators) library(pastclim) -this_file <- pastclim:::get_file_for_dataset("bio01", "Beyer2020")$file_name -this_file <- file.path(get_data_path(), this_file) - +beyer_file <- pastclim:::get_file_for_dataset("bio01", "Beyer2020")$file_name +beyer_file <- file.path(get_data_path(), this_file) ## subset to a few variables and time steps -cdo (paste0("select,name=bio01,bio10,bio12,biome ",this_file," ex_all_time.nc")) -ncks ("-O -d time,51,71,5 ex_all_time.nc ex_subset.nc") -ncatted ('-O -a description,global,m,c,"Sample dataset to be used in pastclim, a subset of Beyer2020" -h ex_subset.nc') +cdo(paste0("select,name=bio01,bio10,bio12,biome ", beyer_file, " ex_all_time.nc")) +ncks("-O -d time,51,71,5 ex_all_time.nc ex_subset.nc") +ncatted('-O -a description,global,m,c,"Sample dataset to be used in pastclim, a subset of Beyer2020" -h ex_subset.nc') # now upscale the bio variables cdo("select,name=bio01,bio10,bio12 ex_subset.nc ex_bio.nc") @@ -24,31 +31,32 @@ cdo("gridboxmax,2,2 ex_biome.nc ex_biome_max.nc") # this mask is correct for the ice mask cdo("gridboxmin,2,2 ex_biome.nc ex_biome_min.nc") # create an ice mask with the correct ice -cdo ("-O -expr,'biome = ((biome < 28)) ? 0 : -1' ex_biome_min.nc ice1.nc") +cdo("-O -expr,'biome = ((biome < 28)) ? 0 : -1' ex_biome_min.nc ice1.nc") # create mask of ice that is too large -cdo ("-O -expr,'biome = ((biome == 28)) ? 1 : 0' ex_biome_max.nc ice_big.nc") +cdo("-O -expr,'biome = ((biome == 28)) ? 1 : 0' ex_biome_max.nc ice_big.nc") # get the difference -cdo ("-O add ice1.nc ice_big.nc ice_to_remove.nc") -cdo ("-O chname,biome,to_remove ice_to_remove.nc ice_to_remove_rename.nc") -cdo ("-O merge ex_biome_max.nc ice_to_remove_rename.nc ex_biome_temp.nc") -cdo ("-O -expr,'biome = ((to_remove == 1)) ? 27 : biome' ex_biome_temp.nc ex_biome_correct.nc") +cdo("-O add ice1.nc ice_big.nc ice_to_remove.nc") +cdo("-O chname,biome,to_remove ice_to_remove.nc ice_to_remove_rename.nc") +cdo("-O merge ex_biome_max.nc ice_to_remove_rename.nc ex_biome_temp.nc") +cdo("-O -expr,'biome = ((to_remove == 1)) ? 27 : biome' ex_biome_temp.nc ex_biome_correct.nc") # extract the new biome cdo("select,name=biome ex_biome_correct.nc ex_biome_only.nc") # copy all attributes (which were lost) to the file attr_src <- ncdf4::nc_open("ex_all_time.nc") -attr_dest <- ncdf4::nc_open("ex_biome_only.nc",write=TRUE) -ncdf4.helpers::nc.copy.atts(attr_src,"biome",attr_dest,"biome", - exception.list = c("_FillValue")) +attr_dest <- ncdf4::nc_open("ex_biome_only.nc", write = TRUE) +ncdf4.helpers::nc.copy.atts(attr_src, "biome", attr_dest, "biome", + exception.list = c("_FillValue") +) ncdf4::nc_close(attr_src) ncdf4::nc_close(attr_dest) # change the names (we use it to test the ability to convert names if needed) -cdo("-O chname,bio01,BIO1,bio10,BIO10,bio12,BIO12","ex_bio_mean.nc","ex_bio_mean_rename.nc") +cdo("-O chname,bio01,BIO1,bio10,BIO10,bio12,BIO12", "ex_bio_mean.nc", "ex_bio_mean_rename.nc") -cdo("-O -z zip_9 merge ex_bio_mean_rename.nc ex_biome_only.nc",file_name) +cdo("-O -z zip_9 merge ex_bio_mean_rename.nc ex_biome_only.nc", file_name) -ncatted ('-a command_line,global,m,c,"./inst/rawdata_scripts/created_example_dataset.R" -h', file_name) -ncatted ('-a history,global,m,c,"" -h', file_name) -ncatted (paste0('-a pastclim_version,global,m,c,"',file_version,'" -h'), file_name) -cdo("-O -z zip_9 merge ex_bio_mean.nc ex_biome_only.nc","example_to_rename.nc") -file.copy(file_name,to = "~/git/pastclim/inst/extdata/", overwrite = TRUE) +ncatted('-a command_line,global,m,c,"./inst/rawdata_scripts/created_example_dataset.R" -h', file_name) +ncatted('-a history,global,m,c,"" -h', file_name) +ncatted(paste0('-a pastclim_version,global,m,c,"', file_version, '" -h'), file_name) +cdo("-O -z zip_9 merge ex_bio_mean.nc ex_biome_only.nc", "example_to_rename.nc") +file.copy(file_name, to = "~/git/pastclim/inst/extdata/", overwrite = TRUE) diff --git a/data-raw/to_update/extract_topography_for_beyer2020_part1.R b/data-raw/to_update/extract_topography_for_beyer2020_part1.R index 2b428b75..1faa4e15 100644 --- a/data-raw/to_update/extract_topography_for_beyer2020_part1.R +++ b/data-raw/to_update/extract_topography_for_beyer2020_part1.R @@ -25,7 +25,7 @@ problematic_cells <- list() library(terra) for (i in time_steps_bp) { - time_step_row <- - (i / 1000) + 1 + time_step_row <- -(i / 1000) + 1 # now check neighbours of each boundary cell, and expand out if < sea level sea_level_now <- sea_level$SeaLev_longPC1[time_step_row] @@ -72,7 +72,8 @@ for (i in time_steps_bp) { ) rugosity_missing_vals <- rugosity_extra[left_behind_cells] rugosity_missing_vals$focal_mean[ - is.nan(rugosity_missing_vals$focal_mean)] <- NA + is.nan(rugosity_missing_vals$focal_mean) + ] <- NA rugosity_now[left_behind_cells] <- rugosity_missing_vals altitude_extra <- focal( @@ -85,7 +86,8 @@ for (i in time_steps_bp) { ) altitude_missing_vals <- altitude_extra[left_behind_cells] altitude_missing_vals$focal_mean[ - is.nan(altitude_missing_vals$focal_mean)] <- NA + is.nan(altitude_missing_vals$focal_mean) + ] <- NA altitude_now[left_behind_cells] <- altitude_missing_vals left_behind <- terra::mask(land_mask, rugosity_now, inverse = TRUE) diff --git a/data-raw/to_update/extract_topography_for_beyer2020_rewrite.R b/data-raw/to_update/extract_topography_for_beyer2020_rewrite.R new file mode 100644 index 00000000..5c1900ed --- /dev/null +++ b/data-raw/to_update/extract_topography_for_beyer2020_rewrite.R @@ -0,0 +1,133 @@ +#!/usr/bin/env Rscript +library(pastclim) +# arguments when running the code interactively +params <- list( + reference_filename = "Beyer2020_uncut_annual_vars_v1.3.1.nc", + variable = "bio01", + etopo = file.path(get_data_path(), "etopo2022_60s_v1.nc") +) + +# parsing options when run from the command line with Rscript +if (!interactive()) { + library("optparse") + parser <- OptionParser(description = "Compute topographic variable (best used with a reference already cropped for sea ice and internal seas") + + parser <- add_option(parser, c("-rf", "--reference_filename"), + action = "store", + type = "character", help = "reference file to be used to determine dimensions" + ) + parser <- add_option(parser, c("-v", "--variable"), + action = "store", + type = "character", help = "variable to be used in ref file as template for dimensions" + ) + parser <- add_option(parser, c("-e", "--etopo"), + action = "store", + type = "character", help = "file name for etopo" + ) + + # Parse the command line arguments as members of a list called params + params <- parse_args(parser) +} + +# first create a template raster to fill in +mask_nc <- terra::rast(params$reference_filename, + subds = params$variable +) +etopo <- terra::rast(params$etopo) +# crop the extent +etopo <- terra::crop(etopo, mask_nc) +time_steps_bp_all <- time_bp(mask_nc) +time_steps_bp <- c(0, -15000, -20000) +# convert to rows of sea level + +altitude_all <- NULL +rugosity_all <- NULL + +for (i in time_steps_bp) { + sea_level_now <- pastclim:::get_sea_level(i) + + # repeat for the new set of cells that we have identified + # we need to get a land_mask without internal seas + # land_mask <- pastclim::climate_for_time_slice(i, "bio01", dataset) + land_mask <- mask_nc[[which(time_steps_bp == i)]] + + ## consider a stricter land mask with: + # pastclim:::make_land_mask(etopo,time_bp=0)->etopo_test + # to avoid having deep cells close to the coast not being picked up (e.g. South America) + # to speed up things, it would make sense to generate an "always sea map" that can be used to mask + # away some of the sea when computing the landmask + + land_mask[!is.na(land_mask)] <- 1 + bi <- terra::boundaries(land_mask, inner = TRUE) + bi_up <- terra::disagg(bi, fact = 30) + boundary_cells <- which(terra::values(bi_up) == 1) + # subset etopo to the landmask + etopo_now <- terra::mask(etopo, bi_up) + # now set boundary_cells that are below sea level to NA + boundary_under_water <- + boundary_cells[etopo_now[boundary_cells] < sea_level_now] + etopo_now[boundary_under_water] <- NA + rugosity_now <- terra::aggregate(etopo_now, + fact = 30, + fun = sd, + na.rm = TRUE + ) + altitude_now <- terra::aggregate(etopo_now, + fact = 30, + fun = mean, + na.rm = TRUE + ) + # now check if any cell was lost + left_behind <- terra::mask(land_mask, rugosity_now, inverse = TRUE) + left_behind_cells <- which(!is.na(values(left_behind))) + if (length(left_behind_cells) > 0) { + # we need to interpolate those cells + altitude_extra <- altitude_now + rugosity_extra <- rugosity_now + while (length(left_behind_cells) > 0) { + rugosity_extra <- + focal( + rugosity_extra, + w = 3, + fun = mean, + na.rm = TRUE, + NAonly = TRUE, + pad = TRUE + ) + rugosity_missing_vals <- rugosity_extra[left_behind_cells] + rugosity_missing_vals$focal_mean[ + is.nan(rugosity_missing_vals$focal_mean) + ] <- NA + rugosity_now[left_behind_cells] <- rugosity_missing_vals + altitude_extra <- + focal( + altitude_extra, + w = 3, + fun = mean, + na.rm = TRUE, + NAonly = TRUE, + pad = TRUE + ) + altitude_missing_vals <- altitude_extra[left_behind_cells] + altitude_missing_vals$focal_mean[ + is.nan(altitude_missing_vals$focal_mean) + ] <- NA + altitude_now[left_behind_cells] <- altitude_missing_vals + left_behind <- + terra::mask(land_mask, rugosity_now, inverse = TRUE) + left_behind_cells <- which(!is.na(values(left_behind))) + } + } + time_bp(rugosity_now) <- i + time_bp(altitude_now) <- i + # and now we save the rasters + if (is.null(rugosity_all)) { + rugosity_all <- rugosity_now + altitude_all <- altitude_now + } else { + terra::add(rugosity_all) <- rugosity_now + terra::add(altitude_all) <- altitude_now + } +} +# writeCDF(rugosity_all, "rugosity.nc") +# writeCDF(altitude_all, "altitude.nc") diff --git a/data-raw/to_update/extract_topography_for_krapp2021_part1.R b/data-raw/to_update/extract_topography_for_krapp2021_part1.R index 12808c6b..6b508e6b 100644 --- a/data-raw/to_update/extract_topography_for_krapp2021_part1.R +++ b/data-raw/to_update/extract_topography_for_krapp2021_part1.R @@ -47,7 +47,7 @@ time_steps_bp <- time_steps_bp[!is.na(time_steps_bp)] for (i in time_steps_bp) { cat(i) - time_step_row <- - (i / 1000) + 1 + time_step_row <- -(i / 1000) + 1 # now check neighbours of each boundary cell, and expand out if < sea level sea_level_now <- sea_level$SeaLev_longPC1[time_step_row] @@ -94,7 +94,8 @@ for (i in time_steps_bp) { ) rugosity_missing_vals <- rugosity_extra[left_behind_cells] rugosity_missing_vals$focal_mean[ - is.nan(rugosity_missing_vals$focal_mean)] <- NA + is.nan(rugosity_missing_vals$focal_mean) + ] <- NA rugosity_now[left_behind_cells] <- rugosity_missing_vals altitude_extra <- focal( @@ -107,7 +108,8 @@ for (i in time_steps_bp) { ) altitude_missing_vals <- altitude_extra[left_behind_cells] altitude_missing_vals$focal_mean[ - is.nan(altitude_missing_vals$focal_mean)] <- NA + is.nan(altitude_missing_vals$focal_mean) + ] <- NA altitude_now[left_behind_cells] <- altitude_missing_vals left_behind <- terra::mask(land_mask, rugosity_now, inverse = TRUE) diff --git a/data-raw/to_update/repackage_beyer2020 rewrite.R b/data-raw/to_update/repackage_beyer2020 rewrite.R new file mode 100644 index 00000000..f4bd1d3a --- /dev/null +++ b/data-raw/to_update/repackage_beyer2020 rewrite.R @@ -0,0 +1,319 @@ +# This script repackages the Beyer dataset, and creates an annual and monthly set +# of variables. It generates both a "full" dataset with the ice sheets, and a "land" +# dataset with land only (which is the default for pastclim) + +# it can be simply run with something like +# nohup Rscript "~/git/pastclim/data-raw/to_update/repackage_beyer2020 rewrite.R" > repackage_beyer2020.log 2>&1 & +# nohup Rscript "repackage_beyer2020 rewrite.R" > repackage_beyer2020.log 2>&1 & + + +# ideally set up a conda environment before running this script +# conda create --name beyer_repackage +# conda activate beyer_repackage +# conda install -c conda-forge mamba +# mamba install -c conda-forge cdo + +library(reticulate) +use_condaenv("beyer_repackage", required = FALSE) + +# TO UPDATE MANUALLY +file_version <- "1.3.1" +# working directory where the final files will be stored +# wkdir <- "~/datadisk1/project_temp/repackage_beyer" +wkdir <- "~/project_temp/repackage_beyer" + + +# everything below here should work automatically +library(ClimateOperators) +library(ncdf4) + +# output file names +uncut_ann_filename <- paste0("Beyer2020_uncut_annual_vars_v", file_version, ".nc") +uncut_month_filename <- paste0("Beyer2020_uncut_monthly_vars_v", file_version, ".nc") +ann_filename <- paste0("Beyer2020_annual_vars_v", file_version, ".nc") +month_filename <- paste0("Beyer2020_monthly_vars_v", file_version, ".nc") + +# first download the two nc files into the directory `/temp_files/beyer` +# then create internal_seas.nc with `create_internal_seas_raster.R` +# then run this shell script from `/temp_files/beyer` +################################################################################ +# set up the working environment + +# if the working path does not exist, create it +if (!dir.exists(wkdir)) { + dir.create(wkdir) +} +# input file names +beyer1_filename <- file.path(wkdir, "LateQuaternary_Environment.nc") +beyer2_filename <- file.path(wkdir, "LateQuaternary_MonthlyNPP.nc") +setwd(wkdir) +# if the file is not there yet, download it +if (!file.exists(beyer1_filename)) { + curl::multi_download("https://figshare.com/ndownloader/files/22659026", + destfiles = beyer1_filename + ) +} +if (!file.exists(beyer2_filename)) { + curl::multi_download("https://figshare.com/ndownloader/files/28567032", + destfiles = beyer2_filename + ) +} + +################################################################################ +# Now combine the files into a single file +dir.create("temp", showWarnings = FALSE) +# empty it if it already exists +unlink("./temp/*") +# move to temp +setwd("temp") + +## fix coordinate units (they are switched in the original files) +ncatted(paste( + '-a units,longitude,m,c,"degrees_east" -a units,latitude,m,c,"degrees_north"', + beyer1_filename, "LateQuaternary_Environment_coord.nc" +)) +ncatted(paste( + '-a units,longitude,m,c,"degrees_east" -a units,latitude,m,c,"degrees_north"', + beyer2_filename, "LateQuaternary_MonthlyNPP_coord.nc" +)) + +## fix missing values +cdo("-setmissval,nan", "LateQuaternary_Environment_coord.nc", "LateQuaternary_Environment_miss.nc") +cdo("-setmissval,nan", "LateQuaternary_MonthlyNPP_coord.nc", "LateQuaternary_Environment_MonthlyNPP_miss.nc") + +file.remove(c("LateQuaternary_Environment_coord.nc", "LateQuaternary_MonthlyNPP_coord.nc")) + +## Convert biomes to short integers +## (which makes sure that later operations don't become unreliable due to floating point differences) +## We need to ensure that missing values are properly respected (type conversion is messy in that respect) +cdo("-select,name=biome", "LateQuaternary_Environment_MonthlyNPP_miss.nc", "biome_only.nc") +ncap2("-s 'biome=short(biome+1)'", "biome_only.nc", "biome_plus_one.nc") +cdo("-setmissval,-999", "biome_plus_one.nc", "biome_new_nan.nc") +ncap2("-s 'biome=biome-1'", "biome_new_nan.nc", "biome_to_readd.nc") +# re-add the biome that we have now fixed +ncks("-x -v biome", "LateQuaternary_Environment_miss.nc", "LateQuaternary_Environment_u.nc") +unlink("LateQuaternary_Environment_miss.nc") +ncks("-A -v biome", "biome_to_readd.nc", "LateQuaternary_Environment_u.nc") +# clean up +unlink("biome*") + +# copy over monthly npp data to main file +ncks("-A -v mo_npp LateQuaternary_Environment_MonthlyNPP_miss.nc LateQuaternary_Environment_u.nc") +# clean up attributes +ncatted("-a Contact,global,d,, -a Citation,global,d,, -a Title,global,d,, -a Source,global,d,, -a history_of_appended_files,global,d,, -h LateQuaternary_Environment_u.nc") + +# remove the unencessary NPP file +file.remove(c("LateQuaternary_Environment_MonthlyNPP_miss.nc")) + +################################################################################ +# Fix BIO15 +nc_in <- ncdf4::nc_open("LateQuaternary_Environment_u.nc", + write = TRUE +) +precipitation <- ncdf4::ncvar_get(nc_in, "precipitation") +precipitation <- precipitation + 1 + +for (i in 1:(dim(precipitation)[4])) { + precipitation_sub <- precipitation[, , , i] + precipitation_rast <- terra::rast(precipitation_sub) + precipitation_sd <- terra::app(x = precipitation_rast, fun = sd) + precipitation_mean <- terra::app(x = precipitation_rast, fun = mean) + precipitation_cv <- (precipitation_sd / precipitation_mean) * 100 + ncdf4::ncvar_put(nc_in, "BIO15", as.matrix(precipitation_cv, wide = TRUE), + start = c(1, 1, i), count = c(-1, -1, 1) + ) +} + +ncdf4::nc_close(nc_in) + +################################################################################ +## Fix the time units +nc_in <- ncdf4::nc_open("LateQuaternary_Environment_u.nc", + write = TRUE +) +ncdf4::ncvar_put(nc_in, varid = "time", ncdf4::ncvar_get(nc_in, "time") - 120000) +ncdf4::ncatt_put(nc_in, varid = "time", attname = "units", attval = "years since 1950-01-01 00:00:00.0") +ncdf4::ncatt_put(nc_in, varid = "time", attname = "long_name", attval = "years BP") +ncdf4::nc_close(nc_in) + + + +## MISSING bring in the topography variables + +################################################################################ +# Extract the annual variables +select_string <- "-select,name=biome,npp,lai,BIO1,BIO4,BIO5,BIO6,BIO7,BIO8,BIO9,BIO10,BIO11,BIO12,BIO13,BIO14,BIO15,BIO16,BIO17,BIO18,BIO19" +cdo("-z zip_9", select_string, "LateQuaternary_Environment_u.nc", uncut_ann_filename) +# fix climate units +nc_in <- ncdf4::nc_open(uncut_ann_filename, write = TRUE) +old_vars <- c("BIO1", "BIO4", "BIO5", "BIO6", "BIO7", "BIO8", "BIO9", "BIO10", "BIO11", "BIO12", "BIO13", "BIO14", "BIO15", "BIO16", "BIO17", "BIO18", "BIO19") +new_vars <- c("bio01", "bio04", "bio05", "bio06", "bio07", "bio08", "bio09", "bio10", "bio11", "bio12", "bio13", "bio14", "bio15", "bio16", "bio17", "bio18", "bio19") +for (i in 1:length(old_vars)) { + nc_in <- ncdf4::ncvar_rename(nc_in, + old_varname = old_vars[i], + new_varname = new_vars[i] + ) +} +ncdf4::ncatt_put(nc_in, + varid = 0, attname = "description", + attval = "Annual variables from Beyer et al 2020 to be used by the R library pastclim" +) +ncdf4::ncatt_put(nc_in, + varid = 0, attname = "pastclim_version", + attval = file_version +) +ncdf4::ncatt_put(nc_in, + varid = 0, attname = "history", + attval = "" +) +ncdf4::nc_close(nc_in) + + + +################################################################################ +# Extract the monthly variables +select_string <- "-select,name=temperature,precipitation,cloudiness,relative_humidity,wind_speed,mo_npp" +cdo(select_string, "LateQuaternary_Environment_u.nc", "LateQuaternary_Environment_monthly.nc") +file.remove("LateQuaternary_Environment_u.nc") +cdo("splitlevel", "LateQuaternary_Environment_monthly.nc", "Beyer2020_monthly") +file.remove("LateQuaternary_Environment_monthly.nc") +for (i in 1:12) { + if (i < 10) { + month_id <- paste0("0", i) + } else { + month_id <- i + } + file_name <- paste0("Beyer2020_monthly", "0000", month_id) + cdo("vertsum", paste0(file_name, ".nc"), paste0(file_name, "split.nc")) + nc_in <- ncdf4::nc_open(paste0(file_name, "split.nc"), write = TRUE) + var_names <- names(nc_in$var) + for (this_var in var_names) { + this_var_long <- paste( + month.name[i], + ncdf4::ncatt_get(nc_in, this_var, attname = "long_name")$value + ) + ncdf4::ncatt_put(nc_in, this_var, + attname = "long_name", attval = this_var_long, + prec = "text" + ) + nc_in <- ncdf4::ncvar_rename(nc_in, this_var, paste0(this_var, "_", month_id)) + } + ncdf4::nc_close(nc_in) +} + +cdo("-z zip_9", "merge", "*split.nc", uncut_month_filename) + +nc_in <- ncdf4::nc_open(uncut_month_filename, write = TRUE) +ncdf4::ncatt_put(nc_in, + varid = 0, attname = "description", + attval = "Monthly variables from Beyer et al 2020 to be used by the R library pastclim" +) +ncdf4::ncatt_put(nc_in, + varid = 0, attname = "pastclim_version", + attval = file_version +) +ncdf4::ncatt_put(nc_in, + varid = 0, attname = "history", + attval = "" +) +ncdf4::nc_close(nc_in) +unlink("Beyer2020_monthly0*") + + + +################################ +# Now remove ice sheets and internal seas + +# create landmask +cdo("select,name=biome ", uncut_ann_filename, "beyer_biome.nc") +cdo("-O -expr,'biome = ((biome < 28)) ? biome : -1' beyer_biome.nc beyer_biome2.nc") +cdo("-O -expr,'biome = ((biome >= 0)) ? 1 : 0' beyer_biome2.nc beyer_land_only.nc") +file.remove("beyer_biome.nc", "beyer_biome2.nc") + +# create an internal sea raster +library(pastclim) +mask_base <- region_slice(time_bp = 0, "biome", dataset = "custom", path_to_nc = uncut_ann_filename) +internal_seas <- terra::vect("~/git/pastclim/inst/extdata/internal_seas.RDS") +internal_seas <- rasterize(internal_seas, mask_base) +internal_seas[internal_seas == 1] <- 0 +internal_seas[is.nan(internal_seas)] <- 1 +writeCDF(internal_seas, "internal_seas.nc", + varname = "internal_seas", overwrite = TRUE +) +# clean up the internal sea to be formatted correctly +ncks("-C -O -x -v crs internal_seas.nc beyer_internal_seas3.nc") +ncatted("-a grid_mapping,internal_seas,d,, beyer_internal_seas3.nc beyer_internal_seas4.nc") +cdo("invertlat beyer_internal_seas4.nc beyer_internal_seas5.nc") + +cdo("div ", " beyer_land_only.nc beyer_internal_seas5.nc", "land_mask.nc") + +unlink("beyer_internal*") +unlink("internal_seas.nc") +unlink("beyer_land_only.nc") + + +# crop the icesheets +cdo("-z zip_9 div ", uncut_ann_filename, "land_mask.nc", ann_filename) +# readd the biome variables (which we don't want cropped for ice) +ncks("-A -v biome", uncut_ann_filename, ann_filename) +# crop icesheet for monthly data +cdo("-z zip_9 div ", uncut_month_filename, "land_mask.nc", month_filename) + +unlink("land_mask.nc") + +# clean up attributes +nc_in <- ncdf4::nc_open(ann_filename, write = TRUE) +ncdf4::ncatt_put(nc_in, + varid = 0, attname = "description", + attval = "Annual variables from Beyer et al 2020, with ice sheets and internal seas removed, to be used by the R library pastclim" +) +ncdf4::ncatt_put(nc_in, + varid = 0, attname = "history", + attval = "created with repackage_beyer2020.R" +) +ncdf4::nc_close(nc_in) + +nc_in <- ncdf4::nc_open(month_filename, write = TRUE) +ncdf4::ncatt_put(nc_in, + varid = 0, attname = "description", + attval = "Monthly variables from Beyer et al 2020, with ice sheets and internal seas removed, to be used by the R library pastclim" +) +ncdf4::ncatt_put(nc_in, + varid = 0, attname = "history", + attval = "created with repackage_beyer2020.R" +) +ncdf4::nc_close(nc_in) + +# clean up the metadata for the variables based on the information from the pastclim table +full_meta <- pastclim:::dataset_list_included +sub_meta <- full_meta[full_meta$dataset == "Beyer2020", ] +for (i_ncfile in c(uncut_ann_filename, uncut_month_filename, ann_filename, month_filename)) { + nc_in <- ncdf4::nc_open(i_ncfile, write = TRUE) + # update meta units + this_var_names <- names(nc_in$var) + for (x in this_var_names) { + ncdf4::ncatt_put(nc_in, + varid = x, attname = "long_name", + attval = sub_meta$long_name[sub_meta$ncvar == x] + ) + ncdf4::ncatt_put(nc_in, + varid = x, attname = "units", + attval = sub_meta$units[sub_meta$ncvar == x] + ) + } + ncdf4::nc_close(nc_in) + # now remove the attribute unit if present (it should be units) + for (x in this_var_names) { + ncatted(paste0("-a unit,", x, ",d,, -h ", i_ncfile)) + } +} + +# copy it over to the output directory +file.copy(uncut_ann_filename, file.path(wkdir, uncut_ann_filename), + overwrite = TRUE +) +file.copy(uncut_month_filename, file.path(wkdir, uncut_month_filename), + overwrite = TRUE +) +file.copy(ann_filename, file.path(wkdir, ann_filename), overwrite = TRUE) +file.copy(month_filename, file.path(wkdir, month_filename), overwrite = TRUE) diff --git a/data-raw/to_update/repackage_beyer2020_split_annual_monthly.R b/data-raw/to_update/repackage_beyer2020_split_annual_monthly.R deleted file mode 100644 index ca3ddc79..00000000 --- a/data-raw/to_update/repackage_beyer2020_split_annual_monthly.R +++ /dev/null @@ -1,72 +0,0 @@ -library(ClimateOperators) -library(ncdf4) -# annual variables -select_string <- "-select,name=biome,npp,lai,BIO1,BIO4,BIO5,BIO6,BIO7,BIO8,BIO9,BIO10,BIO11,BIO12,BIO13,BIO14,BIO15,BIO16,BIO17,BIO18,BIO19" -cdo("-z zip_9",select_string,"Beyer2020_all_vars_v1.0.0.nc","Beyer2020_annual_vars_v1.1.0_temp.nc") -nc_in<-ncdf4::nc_open("Beyer2020_annual_vars_v1.1.0_temp.nc",write=TRUE) -ncdf4::ncatt_put(nc_in,varid="time", attname = "units",attval = "years since 1950-01-01 00:00:00.0") -ncdf4::ncatt_put(nc_in,varid="time", attname = "long_name",attval = "years BP") -ncdf4::nc_close(nc_in) - -nc_in<-ncdf4::nc_open("Beyer2020_topography_v1.0.0.nc",write=TRUE) -ncdf4::ncvar_put(nc_in,varid="time",vals=get_time_steps("custom","Beyer2020_annual_vars_v1.1.0_temp.nc")) -ncdf4::ncatt_put(nc_in,varid="time", attname = "units",attval = "years since 1950-01-01 00:00:00.0") -ncdf4::ncatt_put(nc_in,varid="time", attname = "long_name",attval = "years BP") -ncdf4::nc_close(nc_in) - -cdo("-z zip_9 merge Beyer2020_annual_vars_v1.1.0_temp.nc Beyer2020_topography_v1.0.0.nc Beyer2020_annual_vars_v1.1.0.nc") -nc_in<-ncdf4::nc_open("Beyer2020_annual_vars_v1.1.0.nc",write=TRUE) -old_vars<-c('BIO1','BIO4','BIO5','BIO6','BIO7','BIO8','BIO9','BIO10','BIO11','BIO12','BIO13','BIO14','BIO15','BIO16','BIO17','BIO18','BIO19') -new_vars<-c('bio01','bio04','bio05','bio06','bio07','bio08','bio09','bio10','bio11','bio12','bio13','bio14','bio15','bio16','bio17','bio18','bio19') -nc_in<-ncdf4::nc_open("Beyer2020_annual_vars_v1.1.0.nc",write=TRUE) -for (i in 1:length(old_vars)){ - nc_in<-ncdf4::ncvar_rename(nc_in, old_varname = old_vars[i], - new_varname = new_vars[i]) -} -ncdf4::ncatt_put(nc_in, varid = 0, attname = "description", - attval = "Annual variables from Beyer et al 2020, with icesheets and internal seas removed, to be used by the R library pastclim") -ncdf4::ncatt_put(nc_in, varid = 0, attname = "pastclim_version", - attval="1.1.0") -ncdf4::ncatt_put(nc_in, varid = 0, attname = "history", - attval="") -ncdf4::nc_close(nc_in) - -###################################### -# monthly variables -select_string <- "-select,name=temperature,precipitation,cloudiness,relative_humidity,wind_speed,mo_npp" -cdo("-z zip_9",select_string,"Beyer2020_all_vars_v1.0.0.nc","Beyer2020_monthly_vars_temp.nc") -cdo("splitlevel","Beyer2020_monthly_vars_temp.nc","Beyer2020_monthly") -for (i in 1:12){ - if (i<10){ - month_id<-paste0("0",i) - } else { - month_id<-i - } - file_name<-paste0("Beyer2020_monthly","0000",month_id) - cdo("vertsum",paste0(file_name,".nc"),paste0(file_name,"s.nc")) - nc_in<-ncdf4::nc_open(paste0(file_name,"s.nc"),write=TRUE) - var_names <- names(nc_in$var) - for (this_var in var_names){ - this_var_long <- paste(month.name[i], - ncdf4::ncatt_get(nc_in, this_var, attname="long_name")$value) - ncdf4::ncatt_put(nc_in, this_var, attname="long_name",attval=this_var_long, - prec="text") - nc_in<-ncdf4::ncvar_rename(nc_in,this_var,paste0(this_var,"_",month_id)) - } - ncdf4::nc_close(nc_in) -} - -cdo ("-z zip_9", "merge","*s.nc","Beyer2020_monthly_vars_v1.1.0.nc") - -nc_in<-ncdf4::nc_open("Beyer2020_monthly_vars_v1.1.0.nc",write=TRUE) -ncdf4::ncatt_put(nc_in, varid = 0, attname = "description", - attval = "Monthly variables from Beyer et al 2020, with icesheets and internal seas removed, to be used by the R library pastclim") -ncdf4::ncatt_put(nc_in, varid = 0, attname = "pastclim_version", - attval="1.1.0") -ncdf4::ncatt_put(nc_in, varid = 0, attname = "history", - attval="") -ncdf4::ncatt_put(nc_in,varid="time", attname = "units",attval = "years since 1950-01-01 00:00:00.0") -ncdf4::ncatt_put(nc_in,varid="time", attname = "long_name",attval = "years BP") -ncdf4::nc_close(nc_in) -unlink("Beyer2020_monthly0*") -unlink("Beyer2020_monthly_vars_temp.nc") diff --git a/data-raw/to_update/repackage_beyer2022h_split_annual_monthly.R b/data-raw/to_update/repackage_beyer2022h_split_annual_monthly.R index 1b934d27..d49d6bad 100644 --- a/data-raw/to_update/repackage_beyer2022h_split_annual_monthly.R +++ b/data-raw/to_update/repackage_beyer2022h_split_annual_monthly.R @@ -3,72 +3,90 @@ library(ncdf4) library(pastclim) # annual variables select_string <- "-select,name=biome,npp,lai,BIO1,BIO4,BIO5,BIO6,BIO7,BIO8,BIO9,BIO10,BIO11,BIO12,BIO13,BIO14,BIO15,BIO16,BIO17,BIO18,BIO19" -cdo("-z zip_9",select_string,"Beyer2022h_all_vars_v1.0.0.nc","Beyer2022h_annual_vars_v1.1.0_temp.nc") -nc_in<-ncdf4::nc_open("Beyer2022h_annual_vars_v1.1.0_temp.nc",write=TRUE) -ncdf4::ncatt_put(nc_in,varid="time", attname = "units",attval = "years since 1950-01-01 00:00:00.0") -ncdf4::ncatt_put(nc_in,varid="time", attname = "long_name",attval = "years BP") +cdo("-z zip_9", select_string, "Beyer2022h_all_vars_v1.0.0.nc", "Beyer2022h_annual_vars_v1.1.0_temp.nc") +nc_in <- ncdf4::nc_open("Beyer2022h_annual_vars_v1.1.0_temp.nc", write = TRUE) +ncdf4::ncatt_put(nc_in, varid = "time", attname = "units", attval = "years since 1950-01-01 00:00:00.0") +ncdf4::ncatt_put(nc_in, varid = "time", attname = "long_name", attval = "years BP") ncdf4::nc_close(nc_in) -nc_in<-ncdf4::nc_open("Beyer2020_topography_v1.0.0.nc",write=TRUE) -ncdf4::ncvar_put(nc_in,varid="time",vals=get_time_steps("custom","Beyer2022h_annual_vars_v1.1.0_temp.nc")) -ncdf4::ncatt_put(nc_in,varid="time", attname = "units",attval = "years since 1950-01-01 00:00:00.0") -ncdf4::ncatt_put(nc_in,varid="time", attname = "long_name",attval = "years BP") +nc_in <- ncdf4::nc_open("Beyer2020_topography_v1.0.0.nc", write = TRUE) +ncdf4::ncvar_put(nc_in, varid = "time", vals = get_time_bp_steps("custom", "Beyer2022h_annual_vars_v1.1.0_temp.nc")) +ncdf4::ncatt_put(nc_in, varid = "time", attname = "units", attval = "years since 1950-01-01 00:00:00.0") +ncdf4::ncatt_put(nc_in, varid = "time", attname = "long_name", attval = "years BP") ncdf4::nc_close(nc_in) cdo("-z zip_9 merge Beyer2022h_annual_vars_v1.1.0_temp.nc Beyer2020_topography_v1.0.0.nc Beyer2022h_annual_vars_v1.1.0.nc") -nc_in<-ncdf4::nc_open("Beyer2022h_annual_vars_v1.1.0.nc",write=TRUE) -old_vars<-c('BIO1','BIO4','BIO5','BIO6','BIO7','BIO8','BIO9','BIO10','BIO11','BIO12','BIO13','BIO14','BIO15','BIO16','BIO17','BIO18','BIO19') -new_vars<-c('bio01','bio04','bio05','bio06','bio07','bio08','bio09','bio10','bio11','bio12','bio13','bio14','bio15','bio16','bio17','bio18','bio19') -nc_in<-ncdf4::nc_open("Beyer2022h_annual_vars_v1.1.0.nc",write=TRUE) -for (i in 1:length(old_vars)){ - nc_in<-ncdf4::ncvar_rename(nc_in, old_varname = old_vars[i], - new_varname = new_vars[i]) +nc_in <- ncdf4::nc_open("Beyer2022h_annual_vars_v1.1.0.nc", write = TRUE) +old_vars <- c("BIO1", "BIO4", "BIO5", "BIO6", "BIO7", "BIO8", "BIO9", "BIO10", "BIO11", "BIO12", "BIO13", "BIO14", "BIO15", "BIO16", "BIO17", "BIO18", "BIO19") +new_vars <- c("bio01", "bio04", "bio05", "bio06", "bio07", "bio08", "bio09", "bio10", "bio11", "bio12", "bio13", "bio14", "bio15", "bio16", "bio17", "bio18", "bio19") +nc_in <- ncdf4::nc_open("Beyer2022h_annual_vars_v1.1.0.nc", write = TRUE) +for (i in 1:length(old_vars)) { + nc_in <- ncdf4::ncvar_rename(nc_in, + old_varname = old_vars[i], + new_varname = new_vars[i] + ) } -ncdf4::ncatt_put(nc_in, varid = 0, attname = "description", - attval = "Annual variables from Beyer et al 2020, with icesheets and internal seas removed, to be used by the R library pastclim") -ncdf4::ncatt_put(nc_in, varid = 0, attname = "pastclim_version", - attval="1.1.0") -ncdf4::ncatt_put(nc_in, varid = 0, attname = "history", - attval="") +ncdf4::ncatt_put(nc_in, + varid = 0, attname = "description", + attval = "Annual variables from Beyer et al 2020, with icesheets and internal seas removed, to be used by the R library pastclim" +) +ncdf4::ncatt_put(nc_in, + varid = 0, attname = "pastclim_version", + attval = "1.1.0" +) +ncdf4::ncatt_put(nc_in, + varid = 0, attname = "history", + attval = "" +) ncdf4::nc_close(nc_in) ###################################### # monthly variables -#select_string <- "-select,name=temperature,precipitation,cloudiness,relative_humidity,wind_speed,mo_npp" +# select_string <- "-select,name=temperature,precipitation,cloudiness,relative_humidity,wind_speed,mo_npp" select_string <- "-select,name=temperature,precipitation,cloudiness,relative_humidity,wind_speed" -cdo("-z zip_9",select_string,"Beyer2022h_all_vars_v1.0.0.nc","Beyer2022h_monthly_vars_temp.nc") -cdo("splitlevel","Beyer2022h_monthly_vars_temp.nc","Beyer2022h_monthly") -for (i in 1:12){ - if (i<10){ - month_id<-paste0("0",i) +cdo("-z zip_9", select_string, "Beyer2022h_all_vars_v1.0.0.nc", "Beyer2022h_monthly_vars_temp.nc") +cdo("splitlevel", "Beyer2022h_monthly_vars_temp.nc", "Beyer2022h_monthly") +for (i in 1:12) { + if (i < 10) { + month_id <- paste0("0", i) } else { - month_id<-i + month_id <- i } - file_name<-paste0("Beyer2022h_monthly","0000",month_id) - cdo("vertsum",paste0(file_name,".nc"),paste0(file_name,"s.nc")) - nc_in<-ncdf4::nc_open(paste0(file_name,"s.nc"),write=TRUE) + file_name <- paste0("Beyer2022h_monthly", "0000", month_id) + cdo("vertsum", paste0(file_name, ".nc"), paste0(file_name, "s.nc")) + nc_in <- ncdf4::nc_open(paste0(file_name, "s.nc"), write = TRUE) var_names <- names(nc_in$var) - for (this_var in var_names){ - this_var_long <- paste(month.name[i], - ncdf4::ncatt_get(nc_in, this_var, attname="long_name")$value) - ncdf4::ncatt_put(nc_in, this_var, attname="long_name",attval=this_var_long, - prec="text") - nc_in<-ncdf4::ncvar_rename(nc_in,this_var,paste0(this_var,"_",month_id)) + for (this_var in var_names) { + this_var_long <- paste( + month.name[i], + ncdf4::ncatt_get(nc_in, this_var, attname = "long_name")$value + ) + ncdf4::ncatt_put(nc_in, this_var, + attname = "long_name", attval = this_var_long, + prec = "text" + ) + nc_in <- ncdf4::ncvar_rename(nc_in, this_var, paste0(this_var, "_", month_id)) } ncdf4::nc_close(nc_in) } -cdo ("-z zip_9", "merge","*s.nc","Beyer2022h_monthly_vars_v1.1.0.nc") +cdo("-z zip_9", "merge", "*s.nc", "Beyer2022h_monthly_vars_v1.1.0.nc") -nc_in<-ncdf4::nc_open("Beyer2022h_monthly_vars_v1.1.0.nc",write=TRUE) -ncdf4::ncatt_put(nc_in, varid = 0, attname = "description", - attval = "Monthly variables from Beyer et al 2020, with icesheets and internal seas removed, to be used by the R library pastclim") -ncdf4::ncatt_put(nc_in, varid = 0, attname = "pastclim_version", - attval="1.1.0") -ncdf4::ncatt_put(nc_in, varid = 0, attname = "history", - attval="") -ncdf4::ncatt_put(nc_in,varid="time", attname = "units",attval = "years since 1950-01-01 00:00:00.0") -ncdf4::ncatt_put(nc_in,varid="time", attname = "long_name",attval = "years BP") +nc_in <- ncdf4::nc_open("Beyer2022h_monthly_vars_v1.1.0.nc", write = TRUE) +ncdf4::ncatt_put(nc_in, + varid = 0, attname = "description", + attval = "Monthly variables from Beyer et al 2020, with icesheets and internal seas removed, to be used by the R library pastclim" +) +ncdf4::ncatt_put(nc_in, + varid = 0, attname = "pastclim_version", + attval = "1.1.0" +) +ncdf4::ncatt_put(nc_in, + varid = 0, attname = "history", + attval = "" +) +ncdf4::ncatt_put(nc_in, varid = "time", attname = "units", attval = "years since 1950-01-01 00:00:00.0") +ncdf4::ncatt_put(nc_in, varid = "time", attname = "long_name", attval = "years BP") ncdf4::nc_close(nc_in) unlink("Beyer2022h_monthly0*") unlink("Beyer2022h_monthly_vars_temp.nc") diff --git a/data-raw/to_update/repackage_krapp2021.R b/data-raw/to_update/repackage_krapp2021.R new file mode 100644 index 00000000..2a6d632a --- /dev/null +++ b/data-raw/to_update/repackage_krapp2021.R @@ -0,0 +1,200 @@ +# This script repackages the Krapp dataset, and creates an annual and monthly set +# of variables. It generates both a "full" dataset with the ice sheets, and a "land" +# dataset with land only (which is the default for pastclim) + +# in a directory called original_files, download the directories: +# bioclimate, precipitation, temperature, vegetation, and total_cloud_cover +# from the OSF site + +# it can be simply run with something like +# nohup Rscript "~/git/pastclim/data-raw/to_update/repackage_krapp2020 rewrite.R" > repackage_krapp2020.log 2>&1 & +# nohup Rscript "repackage_krapp2020 rewrite.R" > repackage_krapp2020.log 2>&1 & + + +# ideally set up a conda environment before running this script +# conda create --name krapp_repackage +# conda activate krapp_repackage +# conda install -c conda-forge mamba +# mamba install -c conda-forge cdo + +library(reticulate) +use_condaenv("beyer_repackage", required = TRUE) + +# TO UPDATE MANUALLY +file_version <- "1.4.0" +# working directory where the final files will be stored +# wkdir <- "/media/andrea/Elements/pastclim/" +wkdir <- "~/datadisk1/pastclim_data/mario/" + +# everything below here should work automatically +library(ClimateOperators) +library(ncdf4) + +setwd(wkdir) + +# names of directory with original files +if (!dir.exists("./repackaged")) { + dir.create("./repackaged") + dir.create("./repackaged/cut") + dir.create("./repackaged/uncut") +} +if (!dir.exists("./temp")) { + dir.create("./temp") +} + +# now process the biomes +if (!dir.exists("./original_files/vegetation_annual")) { + dir.create("./original_files/vegetation_annual") +} +if (file.exists("./original_files/vegetation/biome4output_800ka.nc")) { + file.copy( + "./original_files/vegetation/biome4output_800ka.nc", + "./original_files/vegetation_annual/biome4output_800ka.nc" + ) + file.remove("./original_files/vegetation/biome4output_800ka.nc") +} + +# create landmask +cdo("select,name=biome ./original_files/vegetation_annual/biome4output_800ka.nc ./temp/krapp_biome.nc") +cdo("-O -expr,'biome = ((biome < 28)) ? biome : -1' ./temp/krapp_biome.nc ./temp/krapp_biome2.nc") +cdo("-O -expr,'biome = ((biome >= 0)) ? 1 : 0' ./temp/krapp_biome2.nc ./temp/krapp_land_only.nc") +file.remove("./temp/krapp_biome.nc", "./temp/krapp_biome2.nc") + +# now process each file +download_dir <- file.path(wkdir, "original_files/bioclimate") +for (file_id in list.files(download_dir, full.names = TRUE)) { + this_file <- basename(file_id) + var1 <- strsplit(this_file, "_")[[1]][1] + if (var1 %in% c("bio13", "bio14")) { # divide by 12 + file_id_temp <- file.path("./temp", this_file) + cdo(paste0("-z zip_5 -b F32 -divc,12. ", file_id, " ", file_id_temp)) + file_id <- file_id_temp + } else if (var1 %in% c("bio16", "bio17", "bio18", "bio19")) { # divide by 4 + file_id_temp <- file.path("./temp", this_file) + cdo(paste0("-z zip_5 -b F32 -divc,4. ", file_id, " ", file_id_temp)) + file_id <- file_id_temp + } + new_file_cut <- file.path("./repackaged/cut", paste0("Krapp2021_", var1, "_v", file_version, ".nc")) + new_file_uncut <- file.path("./repackaged/uncut", paste0("Krapp2021_uncut_", var1, "_v", file_version, ".nc")) + + cdo(paste0("-z zip_9 div ", file_id, " ./temp/krapp_land_only.nc ", new_file_cut)) + + ## TODO this needs to be reinstated to create uncut files + # file.copy(from= file_id, to=new_file_uncut) + # NOTE that the above does not recompress the file + # cdo(paste0("-z zip_9 ",file_id," ",new_file_uncut)) +} + + +## TODO this has not been implemented yet!!!! +# new_file <- file.path("./repackaged/", paste0(var1,"_biome_v",file_version,".nc")) +# ncks(paste0("-C -O -x -v pco2,npp,LAI ", file_id, " ", new_file)) + +################### +# Monthly variables +################### +monthly_dirs <- c("precipitation", "temperature", "vegetation", "total_cloud_cover") +monthly_dirs <- file.path(wkdir, "original_files", monthly_dirs) + +# first combine the files into single uncut files +# first we need to change the var names (so, copy over and change var name) +# cdo ("-z zip_9", "merge","./monthly/biome*.nc","Krapp2021_npp_monthly_v1.1.0.nc") +# cdo ("-z zip_9", "merge","./original_files/precipitation/prec*.nc", +# paste0("./repackaged/uncut/Krapp2021_uncut_prec_monthly_v", file_version,".nc")) +# cdo ("-z zip_9", "merge","./monthly/temp*.nc","Krapp2021_temp_monthly_v1.1.0.nc") +# cdo ("-z zip_9", "merge","./monthly/tcc*.nc","Krapp2021_tcc_monthly_v1.1.0.nc") +# + + +# ##TODO +# #We need a temp/monthly directory +# +# # use the landmask to cut out the ice +# month_prefix<-tolower(substr(month.name,1,3)) +# for (this_file in list.files(monthly_dirs, full.names = TRUE)){ +# i <- basename(this_file) +# # get the month +# this_month<-unlist(strsplit(unlist(strsplit(i,"_"))[3],".",fixed=T))[1] +# this_month_id <- match(this_month,month_prefix) +# if (this_month_id<10){ +# this_month_id <- paste0("0",this_month_id) +# } +# new_filename<-paste(unlist(strsplit(i,"_"))[1:2],collapse="_") +# new_filename<-paste0(new_filename,"_",this_month_id,".nc") +# new_filename<-file.path("./temp/monthly",new_filename) +# # mask the file +# if (unlist(strsplit(i,"_"))[1]=="biome4output"){ +# cdo ("-z zip_9 div -selname,mo_npp",this_file, +# " krapp_land_only.nc ", new_filename)} else +# { cdo ("-z zip_9 div",this_file, +# " krapp_land_only.nc ", new_filename)} +# } +# +# # rename variables +# month_prefix<-tolower(substr(month.name,1,3)) +# long_var_names<-c(biome4output="monthly net primary productivity",prec="monthly precipitation", +# temp="monthly mean temperature",tcc="monthly total cloud cover") +# var_names<-c(biome4output="mo_npp",prec="prec", +# temp="temp",tcc="tcc") +# for (i in dir("./monthly/")){ +# this_month_id<-unlist(strsplit(unlist(strsplit(i,"_"))[3],".",fixed=T))[1] +# this_var <- unlist(strsplit(i,"_"))[1] +# # update the variable name +# ncatted (paste0("-O -a long_name,",var_names[this_var],",o,c,'",month.name[as.numeric(this_month_id)], +# " ",long_var_names[this_var],"' ",file.path("./monthly",i))) +# ncrename("-h -O -v ",csl(var_names[this_var],paste(var_names[this_var],this_month_id,sep="_")),file.path("./monthly",i)) +# } +# +# # now combine monthly estimates for each variable +# cdo ("-z zip_9", "merge","./monthly/biome*.nc","Krapp2021_npp_monthly_v1.1.0.nc") +# cdo ("-z zip_9", "merge","./monthly/prec*.nc","Krapp2021_prec_monthly_v1.1.0.nc") +# cdo ("-z zip_9", "merge","./monthly/temp*.nc","Krapp2021_temp_monthly_v1.1.0.nc") +# cdo ("-z zip_9", "merge","./monthly/tcc*.nc","Krapp2021_tcc_monthly_v1.1.0.nc") + +## example commands for monthly variables to change units +# cdo -z zip_9 -b F32 subc,273.15 Krapp2021_temp_monthly_v1.2.2.nc Krapp2021_temp_monthly_v1.4.0.nc +# cdo -z zip_9 -b F32 divc,12. Krapp2021_prec_monthly_v1.2.2.nc Krapp2021_prec_monthly_v1.4.0.nc +# ncatted -a pastclim_version,global,m,c,'1.4.0' Krapp2021_temp_monthly_v1.4.0.nc +# ncatted -a pastclim_version,global,m,c,'1.4.0' Krapp2021_prec_monthly_v1.4.0.nc + + + + +# NOTE this needs to be changed to work for uncut as well. +for (file_id in list.files("./repackaged/cut", full.names = TRUE)) { + ncatted(paste0("-a author,global,d,, -a history,global,d,, -a description,global,d,, -a command_line,global,d,, -h ", file_id)) + ncatted(paste0("-a created_by,global,c,c,'Andrea Manica' -a pastclim_version,global,c,c,'", file_version, "' ", file_id)) + ncatted(paste0("-a link,global,a,c,'https://github.com/EvolEcolGroup/pastclim' -a description,global,a,c,'Data from Krapp et al 2021, with icesheets and internal seas removed, to be used by the R library pastclim' -a history,global,d,, -a history_of_appended_files,global,d,, -h ", file_id)) + # ncatted (paste0("-a units,time,m,c,'years since 1950-01-01 00:00:00.0' -h ",file_id)) + ncatted(paste0("-a command_line,global,c,c,'./inst/rawdata_scripts/repackage_krapp2021.R' -h ", file_id)) + # format time axis + nc_in <- ncdf4::nc_open(file_id, write = TRUE) + ncdf4::ncatt_put(nc_in, varid = "time", attname = "units", attval = "years since 1950-01-01 00:00:00.0") + ncdf4::ncatt_put(nc_in, varid = "time", attname = "long_name", attval = "years BP") + ncdf4::ncatt_put(nc_in, varid = "time", attname = "axis", attval = "T") + ncdf4::nc_close(nc_in) +} + +# clean up the metadata for the variables based on the information from the pastclim table +full_meta <- pastclim:::dataset_list_included +sub_meta <- full_meta[full_meta$dataset == "Krapp2021", ] +for (i_ncfile in list.files("./repackaged/cut", full.names = TRUE)) { + nc_in <- ncdf4::nc_open(i_ncfile, write = TRUE) + # update meta units + this_var_names <- names(nc_in$var) + for (x in this_var_names) { + ncdf4::ncatt_put(nc_in, + varid = x, attname = "long_name", + attval = sub_meta$long_name[sub_meta$ncvar == x] + ) + ncdf4::ncatt_put(nc_in, + varid = x, attname = "units", + attval = sub_meta$units[sub_meta$ncvar == x] + ) + } + ncdf4::nc_close(nc_in) + # now remove the attribute unit if present (it should be units) + for (x in this_var_names) { + ncatted(paste0("-a unit,", x, ",d,, -h ", i_ncfile)) + } +} diff --git a/data-raw/to_update/repackage_krapp2021_monthly.R b/data-raw/to_update/repackage_krapp2021_monthly.R new file mode 100644 index 00000000..7a61ab53 --- /dev/null +++ b/data-raw/to_update/repackage_krapp2021_monthly.R @@ -0,0 +1,78 @@ +# Download monthly data from osf +# https://osf.io/8n43x/files/osfstorage +# Unpack all the files in ./orig_files and remove annual estimates +# download the biome file into the root directory +dir.create("./monthly") + +library(ClimateOperators) +# create landmask +cdo("select,name=biome ./biome4output_800ka.nc krapp_biome.nc") +cdo("-O -expr,'biome = ((biome < 28)) ? biome : -1' krapp_biome.nc krapp_biome2.nc") +cdo("-O -expr,'biome = ((biome >= 0)) ? 1 : 0' krapp_biome2.nc krapp_land_only.nc") +unlink(c("krapp_biome.nc", "krapp_biome2.nc")) + +# use the landmask to cut out the ice +library(pastclim) +month_prefix <- tolower(substr(month.name, 1, 3)) +for (i in (dir("./original_files/")[34:36])) { + # get the month + this_month <- unlist(strsplit(unlist(strsplit(i, "_"))[3], ".", fixed = T))[1] + this_month_id <- match(this_month, month_prefix) + if (this_month_id < 10) { + this_month_id <- paste0("0", this_month_id) + } + new_filename <- paste(unlist(strsplit(i, "_"))[1:2], collapse = "_") + new_filename <- paste0(new_filename, "_", this_month_id, ".nc") + new_filename <- file.path("./monthly", new_filename) + # mask the file + if (unlist(strsplit(i, "_"))[1] == "biome4output") { + cdo( + "-z zip_9 div -selname,mo_npp", file.path("./original_files", i), + " krapp_land_only.nc ", new_filename + ) + } else { + cdo( + "-z zip_9 div", file.path("./original_files", i), + " krapp_land_only.nc ", new_filename + ) + } +} + +# rename variables +month_prefix <- tolower(substr(month.name, 1, 3)) +long_var_names <- c( + biome4output = "monthly net primary productivity", prec = "monthly precipitation", + temp = "monthly mean temperature", tcc = "monthly total cloud cover" +) +var_names <- c( + biome4output = "mo_npp", prec = "prec", + temp = "temp", tcc = "tcc" +) +for (i in dir("./monthly/")) { + this_month_id <- unlist(strsplit(unlist(strsplit(i, "_"))[3], ".", fixed = T))[1] + this_var <- unlist(strsplit(i, "_"))[1] + # update the variable name + ncatted(paste0( + "-O -a long_name,", var_names[this_var], ",o,c,'", month.name[as.numeric(this_month_id)], + " ", long_var_names[this_var], "' ", file.path("./monthly", i) + )) + ncrename("-h -O -v ", csl(var_names[this_var], paste(var_names[this_var], this_month_id, sep = "_")), file.path("./monthly", i)) +} + +# now combine monthly estimates for each variable +cdo("-z zip_9", "merge", "./monthly/biome*.nc", "Krapp2021_npp_monthly_v1.1.0.nc") +cdo("-z zip_9", "merge", "./monthly/prec*.nc", "Krapp2021_prec_monthly_v1.1.0.nc") +cdo("-z zip_9", "merge", "./monthly/temp*.nc", "Krapp2021_temp_monthly_v1.1.0.nc") +cdo("-z zip_9", "merge", "./monthly/tcc*.nc", "Krapp2021_tcc_monthly_v1.1.0.nc") + +# update time variable +for (outfile_name in c( + "Krapp2021_npp_monthly_v1.1.0.nc", "Krapp2021_prec_monthly_v1.1.0.nc", + "Krapp2021_temp_monthly_v1.1.0.nc", "Krapp2021_tcc_monthly_v1.1.0.nc" +)) { + nc_in <- ncdf4::nc_open(outfile_name, write = TRUE) + ncdf4::ncatt_put(nc_in, varid = "time", attname = "units", attval = "years since 1950-01-01 00:00:00.0") + ncdf4::ncatt_put(nc_in, varid = "time", attname = "long_name", attval = "years BP") + ncdf4::ncatt_put(nc_in, varid = "time", attname = "axis", attval = "T") + ncdf4::nc_close(nc_in) +} diff --git a/data-raw/to_update/rewrite_global_attributes.R b/data-raw/to_update/rewrite_global_attributes.R index 66129ac7..e2a94707 100644 --- a/data-raw/to_update/rewrite_global_attributes.R +++ b/data-raw/to_update/rewrite_global_attributes.R @@ -1,3 +1,6 @@ +# a function to rewrite the global attributes of an nc file to create a dataset +# for pastclim + rewrite_global_attributes <- function(old_filename, new_filename, @@ -6,23 +9,29 @@ rewrite_global_attributes <- new_filename <- paste0(new_filename, "_v", version, ".nc") ncatted_string <- "-a created_by,global,c,c,'Andrea Manica'" ncatted_string <- - paste0(ncatted_string, - " -a pastclim_version,global,c,c,'", - version, - "'") + paste0( + ncatted_string, + " -a pastclim_version,global,c,c,'", + version, + "'" + ) ncatted_string <- paste0( ncatted_string, " -a link,global,c,c,'https://github.com/EvolEcolGroup/pastclim'" ) ncatted_string <- - paste0(ncatted_string, - " -a description,global,a,c,'", - description, - "'") + paste0( + ncatted_string, + " -a description,global,a,c,'", + description, + "'" + ) ncatted_string <- - paste0(ncatted_string, - " -a history,global,d,, -a history_of_appended_files,global,d,,") + paste0( + ncatted_string, + " -a history,global,d,, -a history_of_appended_files,global,d,," + ) ncatted_string <- paste0(ncatted_string, " -h ", old_filename, " ", new_filename) ret <- system2("ncatted", ncatted_string) diff --git a/data-raw/to_update/create_example_dataset.sh b/data-raw/to_update/superseded/create_example_dataset.sh similarity index 100% rename from data-raw/to_update/create_example_dataset.sh rename to data-raw/to_update/superseded/create_example_dataset.sh diff --git a/data-raw/to_update/create_internal_seas_raster.R b/data-raw/to_update/superseded/create_internal_seas_raster.R similarity index 83% rename from data-raw/to_update/create_internal_seas_raster.R rename to data-raw/to_update/superseded/create_internal_seas_raster.R index 6fd00d29..b0245e03 100644 --- a/data-raw/to_update/create_internal_seas_raster.R +++ b/data-raw/to_update/superseded/create_internal_seas_raster.R @@ -26,10 +26,11 @@ internal_seas[internal_seas == 1] <- NaN internal_seas[internal_seas == 0] <- 1 internal_seas[is.nan(internal_seas)] <- 0 writeCDF(internal_seas, "./inst/rawdata_scripts/temp_files/internal_seas.nc", - varname="internal_seas", overwrite=TRUE) + varname = "internal_seas", overwrite = TRUE +) library(ClimateOperators) -#cdo("--reduce_dim -copy ./inst/rawdata_scripts/temp_files/internal_seas_w_time.nc ./inst/rawdata_scripts/temp_files/internal_seas.nc") -#unlink("./inst/rawdata_scripts/temp_files/internal_seas_w_time.nc") +# cdo("--reduce_dim -copy ./inst/rawdata_scripts/temp_files/internal_seas_w_time.nc ./inst/rawdata_scripts/temp_files/internal_seas.nc") +# unlink("./inst/rawdata_scripts/temp_files/internal_seas_w_time.nc") unlink("./inst/rawdata_scripts/temp_files/shapefiles_internal_seas", recursive = TRUE ) diff --git a/data-raw/to_update/recompute_bio15_for_Beyer2020.R b/data-raw/to_update/superseded/recompute_bio15_for_Beyer2020.R similarity index 100% rename from data-raw/to_update/recompute_bio15_for_Beyer2020.R rename to data-raw/to_update/superseded/recompute_bio15_for_Beyer2020.R diff --git a/data-raw/to_update/repackage_beyer2020.sh b/data-raw/to_update/superseded/repackage_beyer2020.sh similarity index 99% rename from data-raw/to_update/repackage_beyer2020.sh rename to data-raw/to_update/superseded/repackage_beyer2020.sh index 2756b14c..1e196b2d 100755 --- a/data-raw/to_update/repackage_beyer2020.sh +++ b/data-raw/to_update/superseded/repackage_beyer2020.sh @@ -30,10 +30,13 @@ ncatted -a units,time,m,c,"years since present" ../internal_seas.nc beyer_intern ncks -C -O -x -v crs beyer_internal_seas2.nc beyer_internal_seas3.nc ncatted -a grid_mapping,internal_seas,d,, beyer_internal_seas3.nc beyer_internal_seas4.nc cdo invertlat beyer_internal_seas4.nc beyer_internal_seas5.nc + # remove internal seas cdo div LateQuaternary_Environment_no_ice.nc beyer_internal_seas5.nc LateQuaternary_Environment_no_internal_seas.nc + # clean up unnecessary files rm beyer* LateQuaternary_Environment_no_ice.nc + # recompress it nccopy -d9 LateQuaternary_Environment_no_internal_seas.nc Beyer2020_all_vars.nc rm LateQuaternary_Environment_no_internal_seas.nc diff --git a/data-raw/to_update/superseded/repackage_beyer2020_split_annual_monthly.R b/data-raw/to_update/superseded/repackage_beyer2020_split_annual_monthly.R new file mode 100644 index 00000000..f1862cb3 --- /dev/null +++ b/data-raw/to_update/superseded/repackage_beyer2020_split_annual_monthly.R @@ -0,0 +1,91 @@ +library(ClimateOperators) +library(ncdf4) +# annual variables +select_string <- "-select,name=biome,npp,lai,BIO1,BIO4,BIO5,BIO6,BIO7,BIO8,BIO9,BIO10,BIO11,BIO12,BIO13,BIO14,BIO15,BIO16,BIO17,BIO18,BIO19" +cdo("-z zip_9", select_string, "Beyer2020_all_vars_v1.0.0.nc", "Beyer2020_annual_vars_v1.1.0_temp.nc") +nc_in <- ncdf4::nc_open("Beyer2020_annual_vars_v1.1.0_temp.nc", write = TRUE) +ncdf4::ncatt_put(nc_in, varid = "time", attname = "units", attval = "years since 1950-01-01 00:00:00.0") +ncdf4::ncatt_put(nc_in, varid = "time", attname = "long_name", attval = "years BP") +ncdf4::nc_close(nc_in) + +nc_in <- ncdf4::nc_open("Beyer2020_topography_v1.0.0.nc", write = TRUE) +ncdf4::ncvar_put(nc_in, varid = "time", vals = get_time_bp_steps("custom", "Beyer2020_annual_vars_v1.1.0_temp.nc")) +ncdf4::ncatt_put(nc_in, varid = "time", attname = "units", attval = "years since 1950-01-01 00:00:00.0") +ncdf4::ncatt_put(nc_in, varid = "time", attname = "long_name", attval = "years BP") +ncdf4::nc_close(nc_in) + +cdo("-z zip_9 merge Beyer2020_annual_vars_v1.1.0_temp.nc Beyer2020_topography_v1.0.0.nc Beyer2020_annual_vars_v1.1.0.nc") + +nc_in <- ncdf4::nc_open("Beyer2020_annual_vars_v1.1.0.nc", write = TRUE) +old_vars <- c("BIO1", "BIO4", "BIO5", "BIO6", "BIO7", "BIO8", "BIO9", "BIO10", "BIO11", "BIO12", "BIO13", "BIO14", "BIO15", "BIO16", "BIO17", "BIO18", "BIO19") +new_vars <- c("bio01", "bio04", "bio05", "bio06", "bio07", "bio08", "bio09", "bio10", "bio11", "bio12", "bio13", "bio14", "bio15", "bio16", "bio17", "bio18", "bio19") +nc_in <- ncdf4::nc_open("Beyer2020_annual_vars_v1.1.0.nc", write = TRUE) +for (i in 1:length(old_vars)) { + nc_in <- ncdf4::ncvar_rename(nc_in, + old_varname = old_vars[i], + new_varname = new_vars[i] + ) +} +ncdf4::ncatt_put(nc_in, + varid = 0, attname = "description", + attval = "Annual variables from Beyer et al 2020, with icesheets and internal seas removed, to be used by the R library pastclim" +) +ncdf4::ncatt_put(nc_in, + varid = 0, attname = "pastclim_version", + attval = "1.1.0" +) +ncdf4::ncatt_put(nc_in, + varid = 0, attname = "history", + attval = "" +) +ncdf4::nc_close(nc_in) + +###################################### +# monthly variables +select_string <- "-select,name=temperature,precipitation,cloudiness,relative_humidity,wind_speed,mo_npp" +cdo("-z zip_9", select_string, "Beyer2020_all_vars_v1.0.0.nc", "Beyer2020_monthly_vars_temp.nc") +cdo("splitlevel", "Beyer2020_monthly_vars_temp.nc", "Beyer2020_monthly") +for (i in 1:12) { + if (i < 10) { + month_id <- paste0("0", i) + } else { + month_id <- i + } + file_name <- paste0("Beyer2020_monthly", "0000", month_id) + cdo("vertsum", paste0(file_name, ".nc"), paste0(file_name, "s.nc")) + nc_in <- ncdf4::nc_open(paste0(file_name, "s.nc"), write = TRUE) + var_names <- names(nc_in$var) + for (this_var in var_names) { + this_var_long <- paste( + month.name[i], + ncdf4::ncatt_get(nc_in, this_var, attname = "long_name")$value + ) + ncdf4::ncatt_put(nc_in, this_var, + attname = "long_name", attval = this_var_long, + prec = "text" + ) + nc_in <- ncdf4::ncvar_rename(nc_in, this_var, paste0(this_var, "_", month_id)) + } + ncdf4::nc_close(nc_in) +} + +cdo("-z zip_9", "merge", "*s.nc", "Beyer2020_monthly_vars_v1.1.0.nc") + +nc_in <- ncdf4::nc_open("Beyer2020_monthly_vars_v1.1.0.nc", write = TRUE) +ncdf4::ncatt_put(nc_in, + varid = 0, attname = "description", + attval = "Monthly variables from Beyer et al 2020, with icesheets and internal seas removed, to be used by the R library pastclim" +) +ncdf4::ncatt_put(nc_in, + varid = 0, attname = "pastclim_version", + attval = "1.1.0" +) +ncdf4::ncatt_put(nc_in, + varid = 0, attname = "history", + attval = "" +) +ncdf4::ncatt_put(nc_in, varid = "time", attname = "units", attval = "years since 1950-01-01 00:00:00.0") +ncdf4::ncatt_put(nc_in, varid = "time", attname = "long_name", attval = "years BP") +ncdf4::nc_close(nc_in) +unlink("Beyer2020_monthly0*") +unlink("Beyer2020_monthly_vars_temp.nc") diff --git a/data-raw/to_update/update_meta_data_of_vars_in_nc.R b/data-raw/to_update/update_meta_data_of_vars_in_nc.R new file mode 100644 index 00000000..467725e6 --- /dev/null +++ b/data-raw/to_update/update_meta_data_of_vars_in_nc.R @@ -0,0 +1,46 @@ +# read.csv(system.file("rawdata_scripts/data_files/variable_table_complete_meta.csv", +# library="pastclim")) +library(ClimateOperators) +dataset <- "Krapp2021" +version_number <- "1.2.2" +out_dir <- "../../project_temp/past_climate/new_meta" +full_meta <- read.csv("./inst/rawdata_scripts/data_files/variable_table_complete_meta.csv") +data_path <- get_data_path() +sub_meta <- full_meta[full_meta$dataset == dataset, ] +target_files <- unique(sub_meta$file_name) + +for (i in target_files) { + name_components <- unlist(strsplit(i, "_", fixed = TRUE)) + # replace the last component with new version + name_components <- name_components[-length(name_components)] + new_name <- paste(paste(name_components, collapse = "_"), paste0("v", version_number, ".nc"), sep = "_") + new_target_path <- file.path(out_dir, new_name) + old_target_path <- file.path(get_data_path(), i) + file.copy(old_target_path, new_target_path) + nc_in <- ncdf4::nc_open(new_target_path, write = TRUE) + # update time units + ncdf4::ncatt_put(nc_in, varid = "time", attname = "units", attval = "years since 1950-01-01 00:00:00.0") + ncdf4::ncatt_put(nc_in, varid = "time", attname = "long_name", attval = "years BP") + # update meta units + this_var_names <- names(nc_in$var) + for (x in this_var_names) { + ncdf4::ncatt_put(nc_in, + varid = x, attname = "long_name", + attval = sub_meta$long_name[sub_meta$ncvar == x] + ) + ncdf4::ncatt_put(nc_in, + varid = x, attname = "units", + attval = sub_meta$units[sub_meta$ncvar == x] + ) + } + ncdf4::ncatt_put(nc_in, + varid = 0, attname = "pastclim_version", + attval = version_number + ) + + ncdf4::nc_close(nc_in) + # now remove the attribute unit if present (it should be units) + for (x in this_var_names) { + ncatted(paste0("-a unit,", x, ",d,, -h ", new_target_path)) + } +} diff --git a/inst/WORDLIST b/inst/WORDLIST index 67b26eec..0d779f8e 100644 --- a/inst/WORDLIST +++ b/inst/WORDLIST @@ -1,51 +1,101 @@ +ANUCLIM CHELSA +CMCC CMD +CMIP +CSM Chalki +ESM +ETOPO Edmundson Eleru +FIO +Fick +GC +GCM +GCMs +GFDL +GISS +Geosci +HR HadCM +HadGEM +Hijmans +INM +IPSL Iho +LR +Longmore +MIROC MIS -NETCDF +NA's OSF +PALEO +PGEM Palaeoclimate +Pereira +Plio +RES +RESm +Rangel Riera +SSP +SSPs Sci SpatRaster -SpatRasters SpatRasterDataset +Spratt TraCE +Tran +UKESM +WorldClim antimeridian +arcsec arcsecs +bioclim bp +ce cheatsheet +chelsa ci codecov com config +coords csv +cv dir discretisation doi ecog -extdata +ed +etopo geoTIFF indeces knitr kya +kyr lai +landmask longname -macOS +lubridate mis nc netcdf nlyr palaeoclimate +palaeoclimatic params -ptr -sds +prec +sd +ssp +tas +tasmax +tasmin +tavg tempdir -terra +tmax +tmin unioned unioning var diff --git a/inst/extdata/dataset_list_included.csv b/inst/extdata/dataset_list_included.csv deleted file mode 100644 index 0aa66b57..00000000 --- a/inst/extdata/dataset_list_included.csv +++ /dev/null @@ -1,169 +0,0 @@ -variable,ncvar,dataset,monthly,file_name,download_path,file_name_orig,download_path_orig,version,long_name,abbreviated_name,time_frame,units,units_exp,dataset_list_v -bio01,BIO1,Example,FALSE,example_climate_v1.3.0.nc,,,,1.3.0,annual mean temperature,ann. mean T,year,degrees Celsius,*degree*C*,1.3.0 -bio10,BIO10,Example,FALSE,example_climate_v1.3.0.nc,,,,1.3.0,mean temperature of warmest quarter,mean T of warmest qtr,year,degrees Celsius,*degree*C*, -bio12,BIO12,Example,FALSE,example_climate_v1.3.0.nc,,,,1.3.0,annual precipitation,ann. P,year,mm per year,*mm~yr^-1*, -biome,biome,Example,FALSE,example_climate_v1.3.0.nc,,,,1.3.0,biome (from BIOME4),biome,year,,, -bio01,bio01,Beyer2020,FALSE,Beyer2020_annual_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_annual_vars_v1.2.2.nc?download=1,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,annual mean temperature,ann. mean T,year,degrees Celsius,*degree*C*, -bio04,bio04,Beyer2020,FALSE,Beyer2020_annual_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_annual_vars_v1.2.2.nc?download=1,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,temperature seasonality,T season.,year,degrees Celsius,*degree*C*, -bio05,bio05,Beyer2020,FALSE,Beyer2020_annual_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_annual_vars_v1.2.2.nc?download=1,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,maximum temperature of warmest month,max. T of warmest mo.,year,degrees Celsius,*degree*C*, -bio06,bio06,Beyer2020,FALSE,Beyer2020_annual_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_annual_vars_v1.2.2.nc?download=1,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,minimum temperature of coldest month,min. T of coldest mo.,year,degrees Celsius,*degree*C*, -bio07,bio07,Beyer2020,FALSE,Beyer2020_annual_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_annual_vars_v1.2.2.nc?download=1,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,temperature annual range (bio05-bio06),T ann. Range,year,degrees Celsius,*degree*C*, -bio08,bio08,Beyer2020,FALSE,Beyer2020_annual_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_annual_vars_v1.2.2.nc?download=1,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,mean temperature of wettest quarter,mean T of wettest qtr,year,degrees Celsius,*degree*C*, -bio09,bio09,Beyer2020,FALSE,Beyer2020_annual_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_annual_vars_v1.2.2.nc?download=1,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,mean temperature of driest quarter,mean T of driest qtr,year,degrees Celsius,*degree*C*, -bio10,bio10,Beyer2020,FALSE,Beyer2020_annual_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_annual_vars_v1.2.2.nc?download=1,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,mean temperature of warmest quarter,mean T of warmest qtr,year,degrees Celsius,*degree*C*, -bio11,bio11,Beyer2020,FALSE,Beyer2020_annual_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_annual_vars_v1.2.2.nc?download=1,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,mean temperature of coldest quarter,mean T of coldest qtr,year,degrees Celsius,*degree*C*, -bio12,bio12,Beyer2020,FALSE,Beyer2020_annual_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_annual_vars_v1.2.2.nc?download=1,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,annual precipitation,ann. P,year,mm per year,*mm~yr^-1*, -bio13,bio13,Beyer2020,FALSE,Beyer2020_annual_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_annual_vars_v1.2.2.nc?download=1,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,precipitation of wettest month,P of wettest mo.,year,mm per month,*mm~mo^-1*, -bio14,bio14,Beyer2020,FALSE,Beyer2020_annual_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_annual_vars_v1.2.2.nc?download=1,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,precipitation of driest month,P of driest mo.,year,mm per month,*mm~mo^-1*, -bio15,bio15,Beyer2020,FALSE,Beyer2020_annual_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_annual_vars_v1.2.2.nc?download=1,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,precipitation seasonality (coeff var),P season.,year,,, -bio16,bio16,Beyer2020,FALSE,Beyer2020_annual_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_annual_vars_v1.2.2.nc?download=1,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,precipitation of wettest quarter,P of wettest qtr,year,mm per quarter,*mm~qtr^-1*, -bio17,bio17,Beyer2020,FALSE,Beyer2020_annual_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_annual_vars_v1.2.2.nc?download=1,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,precipitation of driest quarter,P of driest qtr,year,mm per quarter,*mm~qtr^-1*, -bio18,bio18,Beyer2020,FALSE,Beyer2020_annual_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_annual_vars_v1.2.2.nc?download=1,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,precipitation of warmest quarter,P of warmest qtr,year,mm per quarter,*mm~qtr^-1*, -bio19,bio19,Beyer2020,FALSE,Beyer2020_annual_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_annual_vars_v1.2.2.nc?download=1,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,precipitation of coldest quarter,P of coldest qtr,year,mm per quarter,*mm~qtr^-1*, -npp,npp,Beyer2020,FALSE,Beyer2020_annual_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_annual_vars_v1.2.2.nc?download=1,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,net primary productivity,NPP,year,gC per m^2 per year,*gC~m^-2~yr^-1*, -lai,lai,Beyer2020,FALSE,Beyer2020_annual_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_annual_vars_v1.2.2.nc?download=1,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,leaf area index,LAI,year,gC per m^2,*gC~m^-2*, -biome,biome,Beyer2020,FALSE,Beyer2020_annual_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_annual_vars_v1.2.2.nc?download=1,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,biome (from BIOME4),biome,year,,, -altitude,altitude,Beyer2020,FALSE,Beyer2020_annual_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_annual_vars_v1.2.2.nc?download=1,,,1.2.2,altitude over the sea level,altitude,year,meters,*m*, -rugosity,rugosity,Beyer2020,FALSE,Beyer2020_annual_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_annual_vars_v1.2.2.nc?download=1,,,1.2.2,rugosity (st. dev. altitude at 1 min),rugosity,year,,, -temperature_01,temperature_01,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,mean temperature Jan,mean T Jan,january,degrees Celsius,*degree*C*, -temperature_02,temperature_02,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,mean temperature Feb,mean T Feb,february,degrees Celsius,*degree*C*, -temperature_03,temperature_03,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,mean temperature Mar,mean T Mar,march,degrees Celsius,*degree*C*, -temperature_04,temperature_04,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,mean temperature Apr,mean T Apr,april,degrees Celsius,*degree*C*, -temperature_05,temperature_05,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,mean temperature May,mean T May,may,degrees Celsius,*degree*C*, -temperature_06,temperature_06,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,mean temperature Jun,mean T Jun,june,degrees Celsius,*degree*C*, -temperature_07,temperature_07,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,mean temperature Jul,mean T Jul,july,degrees Celsius,*degree*C*, -temperature_08,temperature_08,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,mean temperature Aug,mean T Aug,august,degrees Celsius,*degree*C*, -temperature_09,temperature_09,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,mean temperature Sep,mean T Sep,september,degrees Celsius,*degree*C*, -temperature_10,temperature_10,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,mean temperature Oct,mean T Oct,october,degrees Celsius,*degree*C*, -temperature_11,temperature_11,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,mean temperature Nov,mean T Nov,november,degrees Celsius,*degree*C*, -temperature_12,temperature_12,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,mean temperature Dec,mean T Dec,december,degrees Celsius,*degree*C*, -precipitation_01,precipitation_01,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,precipitation Jan,P Jan,january,mm per month,*mm~mo^-1*, -precipitation_02,precipitation_02,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,precipitation Feb,P Feb,february,mm per month,*mm~mo^-1*, -precipitation_03,precipitation_03,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,precipitation Mar,P Mar,march,mm per month,*mm~mo^-1*, -precipitation_04,precipitation_04,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,precipitation Apr,P Apr,april,mm per month,*mm~mo^-1*, -precipitation_05,precipitation_05,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,precipitation May,P May,may,mm per month,*mm~mo^-1*, -precipitation_06,precipitation_06,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,precipitation Jun,P Jun,june,mm per month,*mm~mo^-1*, -precipitation_07,precipitation_07,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,precipitation Jul,P Jul,july,mm per month,*mm~mo^-1*, -precipitation_08,precipitation_08,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,precipitation Aug,P Aug,august,mm per month,*mm~mo^-1*, -precipitation_09,precipitation_09,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,precipitation Sep,P Sep,september,mm per month,*mm~mo^-1*, -precipitation_10,precipitation_10,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,precipitation Oct,P Oct,october,mm per month,*mm~mo^-1*, -precipitation_11,precipitation_11,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,precipitation Nov,P Nov,november,mm per month,*mm~mo^-1*, -precipitation_12,precipitation_12,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,precipitation Dec,P Dec,december,mm per month,*mm~mo^-1*, -cloudiness_01,cloudiness_01,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,cloudiness Jan,cloudiness Jan,january,%,*'%'*, -cloudiness_02,cloudiness_02,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,cloudiness Feb,cloudiness Feb,february,%,*'%'*, -cloudiness_03,cloudiness_03,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,cloudiness Mar,cloudiness Mar,march,%,*'%'*, -cloudiness_04,cloudiness_04,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,cloudiness Apr,cloudiness Apr,april,%,*'%'*, -cloudiness_05,cloudiness_05,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,cloudiness May,cloudiness May,may,%,*'%'*, -cloudiness_06,cloudiness_06,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,cloudiness Jun,cloudiness Jun,june,%,*'%'*, -cloudiness_07,cloudiness_07,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,cloudiness Jul,cloudiness Jul,july,%,*'%'*, -cloudiness_08,cloudiness_08,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,cloudiness Aug,cloudiness Aug,august,%,*'%'*, -cloudiness_09,cloudiness_09,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,cloudiness Sep,cloudiness Sep,september,%,*'%'*, -cloudiness_10,cloudiness_10,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,cloudiness Oct,cloudiness Oct,october,%,*'%'*, -cloudiness_11,cloudiness_11,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,cloudiness Nov,cloudiness Nov,november,%,*'%'*, -cloudiness_12,cloudiness_12,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,cloudiness Dec,cloudiness Dec,december,%,*'%'*, -relative_humidity_01,relative_humidity_01,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,relative humidity Jan,RH Jan,january,%,*'%'*, -relative_humidity_02,relative_humidity_02,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,relative humidity Feb,RH Feb,february,%,*'%'*, -relative_humidity_03,relative_humidity_03,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,relative humidity Mar,RH Mar,march,%,*'%'*, -relative_humidity_04,relative_humidity_04,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,relative humidity Apr,RH Apr,april,%,*'%'*, -relative_humidity_05,relative_humidity_05,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,relative humidity May,RH May,may,%,*'%'*, -relative_humidity_06,relative_humidity_06,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,relative humidity Jun,RH Jun,june,%,*'%'*, -relative_humidity_07,relative_humidity_07,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,relative humidity Jul,RH Jul,july,%,*'%'*, -relative_humidity_08,relative_humidity_08,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,relative humidity Aug,RH Aug,august,%,*'%'*, -relative_humidity_09,relative_humidity_09,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,relative humidity Sep,RH Sep,september,%,*'%'*, -relative_humidity_10,relative_humidity_10,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,relative humidity Oct,RH Oct,october,%,*'%'*, -relative_humidity_11,relative_humidity_11,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,relative humidity Nov,RH Nov,november,%,*'%'*, -relative_humidity_12,relative_humidity_12,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,relative humidity Dec,RH Dec,december,%,*'%'*, -wind_speed_01,wind_speed_01,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,wind speed Jan,WS Jan,january,m per second,*m~s^-1*, -wind_speed_02,wind_speed_02,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,wind speed Feb,WS Feb,february,m per second,*m~s^-1*, -wind_speed_03,wind_speed_03,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,wind speed Mar,WS Mar,march,m per second,*m~s^-1*, -wind_speed_04,wind_speed_04,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,wind speed Apr,WS Apr,april,m per second,*m~s^-1*, -wind_speed_05,wind_speed_05,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,wind speed May,WS May,may,m per second,*m~s^-1*, -wind_speed_06,wind_speed_06,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,wind speed Jun,WS Jun,june,m per second,*m~s^-1*, -wind_speed_07,wind_speed_07,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,wind speed Jul,WS Jul,july,m per second,*m~s^-1*, -wind_speed_08,wind_speed_08,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,wind speed Aug,WS Aug,august,m per second,*m~s^-1*, -wind_speed_09,wind_speed_09,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,wind speed Sep,WS Sep,september,m per second,*m~s^-1*, -wind_speed_10,wind_speed_10,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,wind speed Oct,WS Oct,october,m per second,*m~s^-1*, -wind_speed_11,wind_speed_11,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,wind speed Nov,WS Nov,november,m per second,*m~s^-1*, -wind_speed_12,wind_speed_12,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,wind speed Dec,WS Dec,december,m per second,*m~s^-1*, -mo_npp_01,mo_npp_01,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,net primary productivity Jan,NPP Jan,january,gC per m^2 per month,*gC~m^-2~mo^-1*, -mo_npp_02,mo_npp_02,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,net primary productivity Feb,NPP Feb,february,gC per m^2 per month,*gC~m^-2~mo^-1*, -mo_npp_03,mo_npp_03,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,net primary productivity Mar,NPP Mar,march,gC per m^2 per month,*gC~m^-2~mo^-1*, -mo_npp_04,mo_npp_04,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,net primary productivity Apr,NPP Apr,april,gC per m^2 per month,*gC~m^-2~mo^-1*, -mo_npp_05,mo_npp_05,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,net primary productivity May,NPP May,may,gC per m^2 per month,*gC~m^-2~mo^-1*, -mo_npp_06,mo_npp_06,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,net primary productivity Jun,NPP Jun,june,gC per m^2 per month,*gC~m^-2~mo^-1*, -mo_npp_07,mo_npp_07,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,net primary productivity Jul,NPP Jul,july,gC per m^2 per month,*gC~m^-2~mo^-1*, -mo_npp_08,mo_npp_08,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,net primary productivity Aug,NPP Aug,august,gC per m^2 per month,*gC~m^-2~mo^-1*, -mo_npp_09,mo_npp_09,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,net primary productivity Sep,NPP Sep,september,gC per m^2 per month,*gC~m^-2~mo^-1*, -mo_npp_10,mo_npp_10,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,net primary productivity Oct,NPP Oct,october,gC per m^2 per month,*gC~m^-2~mo^-1*, -mo_npp_11,mo_npp_11,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,net primary productivity Nov,NPP Nov,november,gC per m^2 per month,*gC~m^-2~mo^-1*, -mo_npp_12,mo_npp_12,Beyer2020,TRUE,Beyer2020_monthly_vars_v1.2.2.nc,https://zenodo.org/record/7388091/files/Beyer2020_monthly_vars_v1.2.2.nc?download=1,LateQuaternary_Environment.nc,https://ndownloader.figshare.com/files/22659026,1.2.2,net primary productivity Dec,NPP Dec,december,gC per m^2 per month,*gC~m^-2~mo^-1*, -bio01,bio01,Krapp2021,FALSE,Krapp2021_bio01_v1.2.2.nc,https://zenodo.org/record/7388149/files/Krapp2021_bio01_v1.2.2.nc?download=1,bio01_800ka.nc,https://osf.io/a39gh/?action=download,1.2.2,annual mean temperature,ann. mean T,year,degrees Celsius,*degree*C*, -bio04,bio04,Krapp2021,FALSE,Krapp2021_bio04_v1.2.2.nc,https://zenodo.org/record/7388149/files/Krapp2021_bio04_v1.2.2.nc?download=1,bio04_800ka.nc,https://osf.io/p82ue/?action=download,1.2.2,temperature seasonality,T season.,year,degrees Celsius,*degree*C*, -bio05,bio05,Krapp2021,FALSE,Krapp2021_bio05_v1.2.2.nc,https://zenodo.org/record/7388149/files/Krapp2021_bio05_v1.2.2.nc?download=1,bio05_800ka.nc,https://osf.io/emhp9/?action=download,1.2.2,maximum temperature of warmest month,maximum T of warmest mo.,year,degrees Celsius,*degree*C*, -bio06,bio06,Krapp2021,FALSE,Krapp2021_bio06_v1.2.2.nc,https://zenodo.org/record/7388149/files/Krapp2021_bio06_v1.2.2.nc?download=1,bio06_800ka.nc,https://osf.io/cm923/?action=download,1.2.2,minimum temperature of coldest month,minimum T of coldest mo.,year,degrees Celsius,*degree*C*, -bio07,bio07,Krapp2021,FALSE,Krapp2021_bio07_v1.2.2.nc,https://zenodo.org/record/7388149/files/Krapp2021_bio07_v1.2.2.nc?download=1,bio07_800ka.nc,https://osf.io/prq8n/?action=download,1.2.2,temperature annual range (bio05-bio06),T ann. range (bio05-bio06),year,degrees Celsius,*degree*C*, -bio08,bio08,Krapp2021,FALSE,Krapp2021_bio08_v1.2.2.nc,https://zenodo.org/record/7388149/files/Krapp2021_bio08_v1.2.2.nc?download=1,bio08_800ka.nc,https://osf.io/7jsa8/?action=download,1.2.2,mean temperature of wettest quarter,mean T of wettest qtr,year,degrees Celsius,*degree*C*, -bio09,bio09,Krapp2021,FALSE,Krapp2021_bio09_v1.2.2.nc,https://zenodo.org/record/7388149/files/Krapp2021_bio09_v1.2.2.nc?download=1,bio09_800ka.nc,https://osf.io/zaxku/?action=download,1.2.2,mean temperature of driest quarter,mean T of driest qtr,year,degrees Celsius,*degree*C*, -bio10,bio10,Krapp2021,FALSE,Krapp2021_bio10_v1.2.2.nc,https://zenodo.org/record/7388149/files/Krapp2021_bio10_v1.2.2.nc?download=1,bio10_800ka.nc,https://osf.io/b3kx8/?action=download,1.2.2,mean temperature of warmest quarter,mean T of warmest qtr,year,degrees Celsius,*degree*C*, -bio11,bio11,Krapp2021,FALSE,Krapp2021_bio11_v1.2.2.nc,https://zenodo.org/record/7388149/files/Krapp2021_bio11_v1.2.2.nc?download=1,bio11_800ka.nc,https://osf.io/vaune/?action=download,1.2.2,mean temperature of coldest quarter,mean T of coldest qtr,year,degrees Celsius,*degree*C*, -bio12,bio12,Krapp2021,FALSE,Krapp2021_bio12_v1.2.2.nc,https://zenodo.org/record/7388149/files/Krapp2021_bio12_v1.2.2.nc?download=1,bio12_800ka.nc,https://osf.io/kg9v6/?action=download,1.2.2,annual precipitation,ann. P,year,mm per year,*mm~yr^-1*, -bio13,bio13,Krapp2021,FALSE,Krapp2021_bio13_v1.2.2.nc,https://zenodo.org/record/7388149/files/Krapp2021_bio13_v1.2.2.nc?download=1,bio13_800ka.nc,https://osf.io/2u5c6/?action=download,1.2.2,precipitation of wettest month,P of wettest mo.,year,mm per month,*mm~mo^-1*, -bio14,bio14,Krapp2021,FALSE,Krapp2021_bio14_v1.2.2.nc,https://zenodo.org/record/7388149/files/Krapp2021_bio14_v1.2.2.nc?download=1,bio14_800ka.nc,https://osf.io/z2ewu/?action=download,1.2.2,precipitation of driest month,P of driest mo.,year,mm per month,*mm~mo^-1*, -bio15,bio15,Krapp2021,FALSE,Krapp2021_bio15_v1.2.2.nc,https://zenodo.org/record/7388149/files/Krapp2021_bio15_v1.2.2.nc?download=1,bio15_800ka.nc,https://osf.io/z52xr/?action=download,1.2.2,precipitation seasonality (coefficient of variation),P season. (coefficient of variation),year,,, -bio16,bio16,Krapp2021,FALSE,Krapp2021_bio16_v1.2.2.nc,https://zenodo.org/record/7388149/files/Krapp2021_bio16_v1.2.2.nc?download=1,bio16_800ka.nc,https://osf.io/kn8ma/?action=download,1.2.2,precipitation of wettest quarter,P of wettest qtr,year,mm per quarter,*mm~qtr^-1*, -bio17,bio17,Krapp2021,FALSE,Krapp2021_bio17_v1.2.2.nc,https://zenodo.org/record/7388149/files/Krapp2021_bio17_v1.2.2.nc?download=1,bio17_800ka.nc,https://osf.io/2z8ej/?action=download,1.2.2,precipitation of driest quarter,P of driest qtr,year,mm per quarter,*mm~qtr^-1*, -bio18,bio18,Krapp2021,FALSE,Krapp2021_bio18_v1.2.2.nc,https://zenodo.org/record/7388149/files/Krapp2021_bio18_v1.2.2.nc?download=1,bio18_800ka.nc,https://osf.io/a2uhm/?action=download,1.2.2,precipitation of warmest quarter,P of warmest qtr,year,mm per quarter,*mm~qtr^-1*, -bio19,bio19,Krapp2021,FALSE,Krapp2021_bio19_v1.2.2.nc,https://zenodo.org/record/7388149/files/Krapp2021_bio19_v1.2.2.nc?download=1,bio19_800ka.nc,https://osf.io/3mbd9/?action=download,1.2.2,precipitation of coldest quarter,P of coldest qtr,year,mm per quarter,*mm~qtr^-1*, -npp,npp,Krapp2021,FALSE,Krapp2021_npp_v1.2.2.nc,https://zenodo.org/record/7388149/files/Krapp2021_npp_v1.2.2.nc?download=1,biome4output_800ka.nc,https://osf.io/cf5zp/?action=download,1.2.2,net primary productivity,NPP,year,gC per m^2 per year,*gC~m^-2~yr^-1*, -biome,biome,Krapp2021,FALSE,Krapp2021_biome_v1.2.2.nc,https://zenodo.org/record/7388149/files/Krapp2021_biome_v1.2.2.nc?download=1,biome4output_800ka.nc,https://osf.io/cf5zp/?action=download,1.2.2,biome (from BIOME4),biome (from BIOME4),year,,, -lai,lai,Krapp2021,FALSE,Krapp2021_lai_v1.2.3.nc,https://zenodo.org/record/7434553/files/Krapp2021_lai_v1.2.3.nc?download=1,biome4output_800ka.nc,https://osf.io/cf5zp/?action=download,1.2.3,leaf area index,LAI,year,gC per m^2,*gC~m^-2*, -altitude,altitude,Krapp2021,FALSE,Krapp2021_topography_v1.2.2.nc,https://zenodo.org/record/7388149/files/Krapp2021_topography_v1.2.2.nc?download=1,,,1.2.2,altitude over the sea level,altitude over the sea level,year,m,*m*, -rugosity,rugosity,Krapp2021,FALSE,Krapp2021_topography_v1.2.2.nc,https://zenodo.org/record/7388149/files/Krapp2021_topography_v1.2.2.nc?download=1,,,1.2.2,rugosity,rugosity,year,,, -temperature_01,temp_01,Krapp2021,TRUE,Krapp2021_temp_monthly_v1.2.2.nc,https://zenodo.org/record/7388149/files/Krapp2021_temp_monthly_v1.2.2.nc?download=1,,,1.2.2,mean temperature Jan,mean T Jan,january,degrees Celsius,*degree*C*, -temperature_02,temp_02,Krapp2021,TRUE,Krapp2021_temp_monthly_v1.2.2.nc,https://zenodo.org/record/7388149/files/Krapp2021_temp_monthly_v1.2.2.nc?download=1,,,1.2.2,mean temperature Feb,mean T Feb,february,degrees Celsius,*degree*C*, -temperature_03,temp_03,Krapp2021,TRUE,Krapp2021_temp_monthly_v1.2.2.nc,https://zenodo.org/record/7388149/files/Krapp2021_temp_monthly_v1.2.2.nc?download=1,,,1.2.2,mean temperature Mar,mean T Mar,march,degrees Celsius,*degree*C*, -temperature_04,temp_04,Krapp2021,TRUE,Krapp2021_temp_monthly_v1.2.2.nc,https://zenodo.org/record/7388149/files/Krapp2021_temp_monthly_v1.2.2.nc?download=1,,,1.2.2,mean temperature Apr,mean T Apr,april,degrees Celsius,*degree*C*, -temperature_05,temp_05,Krapp2021,TRUE,Krapp2021_temp_monthly_v1.2.2.nc,https://zenodo.org/record/7388149/files/Krapp2021_temp_monthly_v1.2.2.nc?download=1,,,1.2.2,mean temperature May,mean T May,may,degrees Celsius,*degree*C*, -temperature_06,temp_06,Krapp2021,TRUE,Krapp2021_temp_monthly_v1.2.2.nc,https://zenodo.org/record/7388149/files/Krapp2021_temp_monthly_v1.2.2.nc?download=1,,,1.2.2,mean temperature Jun,mean T Jun,june,degrees Celsius,*degree*C*, -temperature_07,temp_07,Krapp2021,TRUE,Krapp2021_temp_monthly_v1.2.2.nc,https://zenodo.org/record/7388149/files/Krapp2021_temp_monthly_v1.2.2.nc?download=1,,,1.2.2,mean temperature Jul,mean T Jul,july,degrees Celsius,*degree*C*, -temperature_08,temp_08,Krapp2021,TRUE,Krapp2021_temp_monthly_v1.2.2.nc,https://zenodo.org/record/7388149/files/Krapp2021_temp_monthly_v1.2.2.nc?download=1,,,1.2.2,mean temperature Aug,mean T Aug,august,degrees Celsius,*degree*C*, -temperature_09,temp_09,Krapp2021,TRUE,Krapp2021_temp_monthly_v1.2.2.nc,https://zenodo.org/record/7388149/files/Krapp2021_temp_monthly_v1.2.2.nc?download=1,,,1.2.2,mean temperature Sep,mean T Sep,september,degrees Celsius,*degree*C*, -temperature_10,temp_10,Krapp2021,TRUE,Krapp2021_temp_monthly_v1.2.2.nc,https://zenodo.org/record/7388149/files/Krapp2021_temp_monthly_v1.2.2.nc?download=1,,,1.2.2,mean temperature Oct,mean T Oct,october,degrees Celsius,*degree*C*, -temperature_11,temp_11,Krapp2021,TRUE,Krapp2021_temp_monthly_v1.2.2.nc,https://zenodo.org/record/7388149/files/Krapp2021_temp_monthly_v1.2.2.nc?download=1,,,1.2.2,mean temperature Nov,mean T Nov,november,degrees Celsius,*degree*C*, -temperature_12,temp_12,Krapp2021,TRUE,Krapp2021_temp_monthly_v1.2.2.nc,https://zenodo.org/record/7388149/files/Krapp2021_temp_monthly_v1.2.2.nc?download=1,,,1.2.2,mean temperature Dec,mean T Dec,december,degrees Celsius,*degree*C*, -precipitation_01,prec_01,Krapp2021,TRUE,Krapp2021_prec_monthly_v1.2.2.nc,https://zenodo.org/record/7388149/files/Krapp2021_prec_monthly_v1.2.2.nc?download=1,,,1.2.2,precipitation Jan,P Jan,january,mm per month,*mm~mo^-1*, -precipitation_02,prec_02,Krapp2021,TRUE,Krapp2021_prec_monthly_v1.2.2.nc,https://zenodo.org/record/7388149/files/Krapp2021_prec_monthly_v1.2.2.nc?download=1,,,1.2.2,precipitation Feb,P Feb,february,mm per month,*mm~mo^-1*, -precipitation_03,prec_03,Krapp2021,TRUE,Krapp2021_prec_monthly_v1.2.2.nc,https://zenodo.org/record/7388149/files/Krapp2021_prec_monthly_v1.2.2.nc?download=1,,,1.2.2,precipitation Mar,P Mar,march,mm per month,*mm~mo^-1*, -precipitation_04,prec_04,Krapp2021,TRUE,Krapp2021_prec_monthly_v1.2.2.nc,https://zenodo.org/record/7388149/files/Krapp2021_prec_monthly_v1.2.2.nc?download=1,,,1.2.2,precipitation Apr,P Apr,april,mm per month,*mm~mo^-1*, -precipitation_05,prec_05,Krapp2021,TRUE,Krapp2021_prec_monthly_v1.2.2.nc,https://zenodo.org/record/7388149/files/Krapp2021_prec_monthly_v1.2.2.nc?download=1,,,1.2.2,precipitation May,P May,may,mm per month,*mm~mo^-1*, -precipitation_06,prec_06,Krapp2021,TRUE,Krapp2021_prec_monthly_v1.2.2.nc,https://zenodo.org/record/7388149/files/Krapp2021_prec_monthly_v1.2.2.nc?download=1,,,1.2.2,precipitation Jun,P Jun,june,mm per month,*mm~mo^-1*, -precipitation_07,prec_07,Krapp2021,TRUE,Krapp2021_prec_monthly_v1.2.2.nc,https://zenodo.org/record/7388149/files/Krapp2021_prec_monthly_v1.2.2.nc?download=1,,,1.2.2,precipitation Jul,P Jul,july,mm per month,*mm~mo^-1*, -precipitation_08,prec_08,Krapp2021,TRUE,Krapp2021_prec_monthly_v1.2.2.nc,https://zenodo.org/record/7388149/files/Krapp2021_prec_monthly_v1.2.2.nc?download=1,,,1.2.2,precipitation Aug,P Aug,august,mm per month,*mm~mo^-1*, -precipitation_09,prec_09,Krapp2021,TRUE,Krapp2021_prec_monthly_v1.2.2.nc,https://zenodo.org/record/7388149/files/Krapp2021_prec_monthly_v1.2.2.nc?download=1,,,1.2.2,precipitation Sep,P Sep,september,mm per month,*mm~mo^-1*, -precipitation_10,prec_10,Krapp2021,TRUE,Krapp2021_prec_monthly_v1.2.2.nc,https://zenodo.org/record/7388149/files/Krapp2021_prec_monthly_v1.2.2.nc?download=1,,,1.2.2,precipitation Oct,P Oct,october,mm per month,*mm~mo^-1*, -precipitation_11,prec_11,Krapp2021,TRUE,Krapp2021_prec_monthly_v1.2.2.nc,https://zenodo.org/record/7388149/files/Krapp2021_prec_monthly_v1.2.2.nc?download=1,,,1.2.2,precipitation Nov,P Nov,november,mm per month,*mm~mo^-1*, -precipitation_12,prec_12,Krapp2021,TRUE,Krapp2021_prec_monthly_v1.2.2.nc,https://zenodo.org/record/7388149/files/Krapp2021_prec_monthly_v1.2.2.nc?download=1,,,1.2.2,precipitation Dec,P Dec,december,mm per month,*mm~mo^-1*, -mo_npp_01,mo_npp_01,Krapp2021,TRUE,Krapp2021_npp_monthly_v1.2.2.nc,https://zenodo.org/record/7388149/files/Krapp2021_npp_monthly_v1.2.2.nc?download=1,,,1.2.2,net primary productivity Jan,NPP Jan,january,gC per m^2 per month,*gC~m^-2~mo^-1*, -mo_npp_02,mo_npp_02,Krapp2021,TRUE,Krapp2021_npp_monthly_v1.2.2.nc,https://zenodo.org/record/7388149/files/Krapp2021_npp_monthly_v1.2.2.nc?download=1,,,1.2.2,net primary productivity Feb,NPP Feb,february,gC per m^2 per month,*gC~m^-2~mo^-1*, -mo_npp_03,mo_npp_03,Krapp2021,TRUE,Krapp2021_npp_monthly_v1.2.2.nc,https://zenodo.org/record/7388149/files/Krapp2021_npp_monthly_v1.2.2.nc?download=1,,,1.2.2,net primary productivity Mar,NPP Mar,march,gC per m^2 per month,*gC~m^-2~mo^-1*, -mo_npp_04,mo_npp_04,Krapp2021,TRUE,Krapp2021_npp_monthly_v1.2.2.nc,https://zenodo.org/record/7388149/files/Krapp2021_npp_monthly_v1.2.2.nc?download=1,,,1.2.2,net primary productivity Apr,NPP Apr,april,gC per m^2 per month,*gC~m^-2~mo^-1*, -mo_npp_05,mo_npp_05,Krapp2021,TRUE,Krapp2021_npp_monthly_v1.2.2.nc,https://zenodo.org/record/7388149/files/Krapp2021_npp_monthly_v1.2.2.nc?download=1,,,1.2.2,net primary productivity May,NPP May,may,gC per m^2 per month,*gC~m^-2~mo^-1*, -mo_npp_06,mo_npp_06,Krapp2021,TRUE,Krapp2021_npp_monthly_v1.2.2.nc,https://zenodo.org/record/7388149/files/Krapp2021_npp_monthly_v1.2.2.nc?download=1,,,1.2.2,net primary productivity Jun,NPP Jun,june,gC per m^2 per month,*gC~m^-2~mo^-1*, -mo_npp_07,mo_npp_07,Krapp2021,TRUE,Krapp2021_npp_monthly_v1.2.2.nc,https://zenodo.org/record/7388149/files/Krapp2021_npp_monthly_v1.2.2.nc?download=1,,,1.2.2,net primary productivity Jul,NPP Jul,july,gC per m^2 per month,*gC~m^-2~mo^-1*, -mo_npp_08,mo_npp_08,Krapp2021,TRUE,Krapp2021_npp_monthly_v1.2.2.nc,https://zenodo.org/record/7388149/files/Krapp2021_npp_monthly_v1.2.2.nc?download=1,,,1.2.2,net primary productivity Aug,NPP Aug,august,gC per m^2 per month,*gC~m^-2~mo^-1*, -mo_npp_09,mo_npp_09,Krapp2021,TRUE,Krapp2021_npp_monthly_v1.2.2.nc,https://zenodo.org/record/7388149/files/Krapp2021_npp_monthly_v1.2.2.nc?download=1,,,1.2.2,net primary productivity Sep,NPP Sep,september,gC per m^2 per month,*gC~m^-2~mo^-1*, -mo_npp_10,mo_npp_10,Krapp2021,TRUE,Krapp2021_npp_monthly_v1.2.2.nc,https://zenodo.org/record/7388149/files/Krapp2021_npp_monthly_v1.2.2.nc?download=1,,,1.2.2,net primary productivity Oct,NPP Oct,october,gC per m^2 per month,*gC~m^-2~mo^-1*, -mo_npp_11,mo_npp_11,Krapp2021,TRUE,Krapp2021_npp_monthly_v1.2.2.nc,https://zenodo.org/record/7388149/files/Krapp2021_npp_monthly_v1.2.2.nc?download=1,,,1.2.2,net primary productivity Nov,NPP Nov,november,gC per m^2 per month,*gC~m^-2~mo^-1*, -mo_npp_12,mo_npp_12,Krapp2021,TRUE,Krapp2021_npp_monthly_v1.2.2.nc,https://zenodo.org/record/7388149/files/Krapp2021_npp_monthly_v1.2.2.nc?download=1,,,1.2.2,net primary productivity Dec,NPP Dec,december,gC per m^2 per month,*gC~m^-2~mo^-1*, -cloudiness_01,tcc_01,Krapp2021,TRUE,Krapp2021_tcc_monthly_v1.2.2.nc,https://zenodo.org/record/7388149/files/Krapp2021_tcc_monthly_v1.2.2.nc?download=1,,,1.2.2,cloudiness Jan,cloudiness Jan,january,%,*'%'*, -cloudiness_02,tcc_02,Krapp2021,TRUE,Krapp2021_tcc_monthly_v1.2.2.nc,https://zenodo.org/record/7388149/files/Krapp2021_tcc_monthly_v1.2.2.nc?download=1,,,1.2.2,cloudiness Feb,cloudiness Feb,february,%,*'%'*, -cloudiness_03,tcc_03,Krapp2021,TRUE,Krapp2021_tcc_monthly_v1.2.2.nc,https://zenodo.org/record/7388149/files/Krapp2021_tcc_monthly_v1.2.2.nc?download=1,,,1.2.2,cloudiness Mar,cloudiness Mar,march,%,*'%'*, -cloudiness_04,tcc_04,Krapp2021,TRUE,Krapp2021_tcc_monthly_v1.2.2.nc,https://zenodo.org/record/7388149/files/Krapp2021_tcc_monthly_v1.2.2.nc?download=1,,,1.2.2,cloudiness Apr,cloudiness Apr,april,%,*'%'*, -cloudiness_05,tcc_05,Krapp2021,TRUE,Krapp2021_tcc_monthly_v1.2.2.nc,https://zenodo.org/record/7388149/files/Krapp2021_tcc_monthly_v1.2.2.nc?download=1,,,1.2.2,cloudiness May,cloudiness May,may,%,*'%'*, -cloudiness_06,tcc_06,Krapp2021,TRUE,Krapp2021_tcc_monthly_v1.2.2.nc,https://zenodo.org/record/7388149/files/Krapp2021_tcc_monthly_v1.2.2.nc?download=1,,,1.2.2,cloudiness Jun,cloudiness Jun,june,%,*'%'*, -cloudiness_07,tcc_07,Krapp2021,TRUE,Krapp2021_tcc_monthly_v1.2.2.nc,https://zenodo.org/record/7388149/files/Krapp2021_tcc_monthly_v1.2.2.nc?download=1,,,1.2.2,cloudiness Jul,cloudiness Jul,july,%,*'%'*, -cloudiness_08,tcc_08,Krapp2021,TRUE,Krapp2021_tcc_monthly_v1.2.2.nc,https://zenodo.org/record/7388149/files/Krapp2021_tcc_monthly_v1.2.2.nc?download=1,,,1.2.2,cloudiness Aug,cloudiness Aug,august,%,*'%'*, -cloudiness_09,tcc_09,Krapp2021,TRUE,Krapp2021_tcc_monthly_v1.2.2.nc,https://zenodo.org/record/7388149/files/Krapp2021_tcc_monthly_v1.2.2.nc?download=1,,,1.2.2,cloudiness Sep,cloudiness Sep,september,%,*'%'*, -cloudiness_10,tcc_10,Krapp2021,TRUE,Krapp2021_tcc_monthly_v1.2.2.nc,https://zenodo.org/record/7388149/files/Krapp2021_tcc_monthly_v1.2.2.nc?download=1,,,1.2.2,cloudiness Oct,cloudiness Oct,october,%,*'%'*, -cloudiness_11,tcc_11,Krapp2021,TRUE,Krapp2021_tcc_monthly_v1.2.2.nc,https://zenodo.org/record/7388149/files/Krapp2021_tcc_monthly_v1.2.2.nc?download=1,,,1.2.2,cloudiness Nov,cloudiness Nov,november,%,*'%'*, -cloudiness_12,tcc_12,Krapp2021,TRUE,Krapp2021_tcc_monthly_v1.2.2.nc,https://zenodo.org/record/7388149/files/Krapp2021_tcc_monthly_v1.2.2.nc?download=1,,,1.2.2,cloudiness Dec,cloudiness Dec,december,%,*'%'*, diff --git a/inst/extdata/delta/prec_obs_hres_all.nc b/inst/extdata/delta/prec_obs_hres_all.nc new file mode 100644 index 00000000..1bffc514 Binary files /dev/null and b/inst/extdata/delta/prec_obs_hres_all.nc differ diff --git a/inst/extdata/delta/prec_series.nc b/inst/extdata/delta/prec_series.nc new file mode 100644 index 00000000..d3e2af18 Binary files /dev/null and b/inst/extdata/delta/prec_series.nc differ diff --git a/inst/extdata/delta/relief.nc b/inst/extdata/delta/relief.nc new file mode 100644 index 00000000..e168af0a Binary files /dev/null and b/inst/extdata/delta/relief.nc differ diff --git a/inst/extdata/delta/tavg_obs_hres_all.nc b/inst/extdata/delta/tavg_obs_hres_all.nc new file mode 100644 index 00000000..2fba66ea Binary files /dev/null and b/inst/extdata/delta/tavg_obs_hres_all.nc differ diff --git a/inst/extdata/delta/tavg_series.nc b/inst/extdata/delta/tavg_series.nc new file mode 100644 index 00000000..b312eb4f Binary files /dev/null and b/inst/extdata/delta/tavg_series.nc differ diff --git a/inst/extdata/internal_seas.RDS b/inst/extdata/internal_seas.RDS new file mode 100644 index 00000000..3bdcd8c4 Binary files /dev/null and b/inst/extdata/internal_seas.RDS differ diff --git a/man/Barreto2023.Rd b/man/Barreto2023.Rd new file mode 100644 index 00000000..5479a095 --- /dev/null +++ b/man/Barreto2023.Rd @@ -0,0 +1,43 @@ +% Generated by roxygen2: do not edit by hand +% Please edit documentation in R/datasets_docs.R +\name{Barreto2023} +\alias{Barreto2023} +\title{Documentation for the Barreto et al 2023 dataset} +\description{ +Spatio-temporal series of monthly temperature and precipitation and 17 +derived bioclimatic variables covering the last 5 Ma (Pliocene–Pleistocene), +at intervals of 1,000 years, and a spatial resolution of 1 +arc-degrees (see Barreto et al., 2023 for details). +} +\details{ +PALEO-PGEM-Series is downscaled to 1 × 1 arc-degrees spatial resolution from the +outputs of the PALEO-PGEM emulator (Holden et al., 2019), which emulates +reasonable and extensively validated global estimates of monthly temperature +and precipitation for the Plio-Pleistocene every 1 kyr at a spatial +resolution of ~5 × 5 arc-degrees (Holden et al., 2016, 2019). + +PALEO-PGEM-Series includes the mean and the standard deviation (i.e., +standard error) of the emulated climate over 10 stochastic GCM emulations +to accommodate aspects of model uncertainty. This allows users to estimate +the robustness of their results in the face of the stochastic aspects of +the emulations. For more details, see Section 2.4 in Barreto et al. (2023). + +Note that this is a very large dataset, with 5001 time slices. It takes +approximately 1 minute to set up each variable when creating a region_slice or +region_series. However, once the object has been created, other operations tend +to be much faster (especially if you subset the dataset to a small number +of time steps of interest). + +If you use this dataset, make sure to cite the original publications: + +Barreto, E., Holden, P. B., Edwards, N. R., & Rangel, T. F. (2023). +PALEO-PGEM-Series: A spatial time series of the global climate over the +last 5 million years (Plio-Pleistocene). Global Ecology and +Biogeography, 32, 1034-1045, +\doi{doi.org/10.1111/geb.13683} + +Holden, P. B., Edwards, N. R., Rangel, T. F., Pereira, E. B., Tran, G. T., +and Wilkinson, R. D. (2019): PALEO-PGEM v1.0: a statistical emulator of +Pliocene–Pleistocene climate, Geosci. Model Dev., 12, 5137–5155, +\doi{doi.org/10.5194/gmd-12-5137-2019}. +} diff --git a/man/Krapp2021.Rd b/man/Krapp2021.Rd index b32803f5..5ea672da 100644 --- a/man/Krapp2021.Rd +++ b/man/Krapp2021.Rd @@ -8,6 +8,9 @@ This dataset covers the last 800k years, at intervals of 1k years, and a resolution of 0.5 degrees in latitude and longitude. } \details{ +The units of several variables have been changed to match what is used +in WorldClim. + If you use this dataset, make sure to cite the original publication: Krapp, M., Beyer, R.M., Edmundson, S.L. et al. A statistics-based @@ -22,6 +25,9 @@ Note that, for bio15, we use the corrected version, which follows Changelog +v1.4.0 Change units to match WorldClim. Fix variable duplication found +on earlier versions of the dataset. + v1.1.0 Added monthly variables. Files can be downloaded from: \url{https://zenodo.org/record/7065055} diff --git a/man/WorldClim_2.1.Rd b/man/WorldClim_2.1.Rd new file mode 100644 index 00000000..2f3ba20a --- /dev/null +++ b/man/WorldClim_2.1.Rd @@ -0,0 +1,50 @@ +% Generated by roxygen2: do not edit by hand +% Please edit documentation in R/datasets_docs.R +\name{WorldClim_2.1} +\alias{WorldClim_2.1} +\alias{WorldClim_2.1_10m} +\alias{WorldClim_2.1_5m} +\title{Documentation for the WorldClim datasets} +\description{ +WorldClim version 2.1 is a database of high spatial resolution global weather and +climate data, covering both the present and future projections. If you use this +dataset, make sure to cite the original publication: +} +\details{ +Fick, S.E. and R.J. Hijmans, 2017. WorldClim 2: new 1km spatial resolution +climate surfaces for global land areas. International Journal of Climatology 37 (12): 4302-4315. +\doi{doi.org/10.1002/joc.5086} + +\strong{Present-day reconstructions} are based on the mean for the period 1970-2000, +and are available at multiple resolutions of +10 arc-minutes, 5 arc-minutes, 2.5 arc-minute and 0.5 arc-minutes. The resolution +of interest can be obtained by changing the ending of the dataset name +\emph{WorldClim_2.1_RESm}, e.g. \emph{WorldClim_2.1_10m} or \emph{WorldClim_2.1_5m} +(currently, only 10m and 5m are currently available in \code{pastclim}). In \code{pastclim}, the datasets are given +a date of 1985 CE (the mid-point of the period of interest), corresponding to +a time_bp of 35. There are 19 “bioclimatic” variables, as well as monthly +estimates for minimum, mean, and maximum temperature, and precipitation. + +\strong{Future projections} are based on the models in CMIP6, downscaled and de-biased +using WorldClim 2.1 for the present as a baseline. Monthly values of minimum +temperature, maximum temperature, and precipitation, as well as 19 bioclimatic +variables were processed for +23 global climate models (GCMs), and for four +Shared Socio-economic Pathways (SSPs): 126, 245, 370 and 585. Model and +SSP can be chosen by changing the ending of the dataset name +\emph{WorldClim_2.1_GCM_SSP_RESm}. + +Available values for GCM are: "ACCESS-CM2", +"BCC-CSM2-MR", "CMCC-ESM2", "EC-Earth3-Veg", "FIO-ESM-2-0", +"GFDL-ESM4", "GISS-E2-1-G", "HadGEM3-GC31-LL", "INM-CM5-0", "IPSL-CM6A-LR", +"MIROC6", "MPI-ESM1-2-HR", "MRI-ESM2-0", and "UKESM1-0-LL". For SSP, use: "ssp126", +"ssp245", "ssp370", and "ssp585". RES takes the same values as for present reconstructions +(i.e. "10m", "5m", "2.5m", and "0.5m"). Example dataset names are +\emph{WorldClim_2.1_ACCESS-CM2_ssp245_10m} and \emph{WorldClim_2.1_MRI-ESM2-0_ssp370_5m} + +The dataset are averages over 20 year +periods (2021-2040, 2041-2060, 2061-2080, 2081-2100). +In \code{pastclim}, the midpoints of the periods (2030, 2050, 2070, 2090) are used as the time stamps. All 4 periods +are automatically downloaded for each combination of GCM model and SSP, and are selected +as usual by defining the time in functions such as \code{\link[=region_slice]{region_slice()}}. +} diff --git a/man/bioclim_vars-methods.Rd b/man/bioclim_vars-methods.Rd new file mode 100644 index 00000000..6264945c --- /dev/null +++ b/man/bioclim_vars-methods.Rd @@ -0,0 +1,72 @@ +% Generated by roxygen2: do not edit by hand +% Please edit documentation in R/bioclim_vars.R +\docType{methods} +\name{bioclim_vars} +\alias{bioclim_vars} +\alias{bioclim_vars,numeric,numeric-method} +\alias{bioclim_vars,SpatRaster,SpatRaster-method} +\alias{bioclim_vars,SpatRasterDataset,SpatRasterDataset-method} +\alias{bioclim_vars,matrix,matrix-method} +\title{Compute bioclimatic variables} +\usage{ +bioclim_vars(prec, tavg, ...) + +\S4method{bioclim_vars}{numeric,numeric}(prec, tavg) + +\S4method{bioclim_vars}{SpatRaster,SpatRaster}(prec, tavg, filename = "", ...) + +\S4method{bioclim_vars}{SpatRasterDataset,SpatRasterDataset}(prec, tavg, filename = "", ...) + +\S4method{bioclim_vars}{matrix,matrix}(prec, tavg) +} +\arguments{ +\item{prec}{monthly precipitation} + +\item{tavg}{monthly average temperatures} + +\item{...}{additional variables for specific methods} + +\item{filename}{filename where the raster can be stored.} +} +\value{ +the bioclim variables +} +\description{ +Function to compute "bioclimatic" variables from +monthly average temperature and precipitation data. For modern data, +this variables are generally computed using min and maximum temperature, +but for many palaeoclimatic reconstructions only average temperature is +available. Most variables, with the exception of BIO02 and BIO03, can +be rephrased meaningfully in terms of mean temperature. +This function is a modified version of \code{predicts::bcvars}. +} +\details{ +The variables are: +\itemize{ +\item BIO01 = Annual Mean Temperature +\item BIO04 = Temperature Seasonality (standard deviation x 100) +\item BIO05 = Max Temperature of Warmest Month +\item BIO06 = Min Temperature of Coldest Month +\item BIO07 = Temperature Annual Range (P5-P6) +\item BIO08 = Mean Temperature of Wettest Quarter +\item BIO09 = Mean Temperature of Driest Quarter +\item BIO10 = Mean Temperature of Warmest Quarter +\item BIO11 = Mean Temperature of Coldest Quarter +\item BIO12 = Annual Precipitation +\item BIO13 = Precipitation of Wettest Month +\item BIO14 = Precipitation of Driest Month +\item BIO15 = Precipitation Seasonality (Coefficient of Variation) +\item BIO16 = Precipitation of Wettest Quarter +\item BIO17 = Precipitation of Driest Quarter +\item BIO18 = Precipitation of Warmest Quarter +\item BIO19 = Precipitation of Coldest Quarter +} + +These summary Bioclimatic variables are after: + +Nix, 1986. A biogeographic analysis of Australian elapid snakes. In: R. Longmore (ed.). +Atlas of elapid snakes of Australia. Australian Flora and Fauna Series 7. +Australian Government Publishing Service, Canberra. + +and expanded following the ANUCLIM manual +} diff --git a/man/check_coords_names.Rd b/man/check_coords_names.Rd new file mode 100644 index 00000000..cee1fc6d --- /dev/null +++ b/man/check_coords_names.Rd @@ -0,0 +1,22 @@ +% Generated by roxygen2: do not edit by hand +% Please edit documentation in R/check_coords_names.R +\name{check_coords_names} +\alias{check_coords_names} +\title{Check that we have a valid pair of coordinate names} +\usage{ +check_coords_names(data, coords) +} +\arguments{ +\item{data}{a data.frame containing the locations.} + +\item{coords}{a vector of length two giving the names of the "x" and "y" +coordinates, of points is a data.frame and does not use standard names.} +} +\value{ +A vector of length 2 with the valid names, in the correct order +} +\description{ +This internal function checks that coords (as passed to functions) is a valid +set of names, or, if NULL, that we have standard variable names in data +} +\keyword{internal} diff --git a/man/check_time_vars.Rd b/man/check_time_vars.Rd new file mode 100644 index 00000000..57a3927d --- /dev/null +++ b/man/check_time_vars.Rd @@ -0,0 +1,22 @@ +% Generated by roxygen2: do not edit by hand +% Please edit documentation in R/check_times.R +\name{check_time_vars} +\alias{check_time_vars} +\title{Check multiple time variables} +\usage{ +check_time_vars(time_bp, time_ce, allow_null = TRUE) +} +\arguments{ +\item{time_bp}{times in bp} + +\item{time_ce}{times in ce} + +\item{allow_null}{boolean whether both can be NULL} +} +\value{ +times in bp +} +\description{ +Check that we only have one set of times +} +\keyword{internal} diff --git a/man/climate_for_locations.Rd b/man/climate_for_locations.Rd index 1612bf84..25f85636 100644 --- a/man/climate_for_locations.Rd +++ b/man/climate_for_locations.Rd @@ -1,17 +1,24 @@ % Generated by roxygen2: do not edit by hand -% Please edit documentation in R/location_slice.R +% Please edit documentation in R/location_slice.R, +% R/location_slice_from_region_series.R \name{climate_for_locations} \alias{climate_for_locations} \title{Extract local climate for one or more locations for a given time slice.} \usage{ +climate_for_locations(...) + climate_for_locations(...) } \arguments{ \item{...}{arguments to be passed to \code{\link[=location_slice]{location_slice()}}} } \value{ +a data.frame with the climatic variables of interest + a data.frame with the climatic variables of interest } \description{ +Deprecated version of \code{\link[=location_slice]{location_slice()}} + Deprecated version of \code{\link[=location_slice]{location_slice()}} } diff --git a/man/distance_from_sea.Rd b/man/distance_from_sea.Rd index 5313992f..f5f0135b 100644 --- a/man/distance_from_sea.Rd +++ b/man/distance_from_sea.Rd @@ -4,17 +4,20 @@ \alias{distance_from_sea} \title{Compute a raster of distances from the sea for each land pixel.} \usage{ -distance_from_sea(time_bp, dataset) +distance_from_sea(time_bp = NULL, time_ce = NULL, dataset) } \arguments{ \item{time_bp}{time slice in years before present (negative)} +\item{time_ce}{time slice in years CE. +Only one of \code{time_bp} or \code{time_ce} should be used.} + \item{dataset}{string defining the dataset to use (a list of possible -values can be obtained with \code{\link[=get_available_datasets]{get_available_datasets()}}). This function +values can be obtained with \code{\link[=list_available_datasets]{list_available_datasets()}}). This function will not work on custom datasets.} } \value{ -a \code{\link[terra:SpatRaster-class]{terra::SpatRaster}} of distances +a \code{\link[terra:SpatRaster-class]{terra::SpatRaster}} of distances from the coastline in km } \description{ Get the land mask for a dataset at a given time point, and compute distance diff --git a/man/dot-cv.Rd b/man/dot-cv.Rd new file mode 100644 index 00000000..b68ce2ec --- /dev/null +++ b/man/dot-cv.Rd @@ -0,0 +1,24 @@ +% Generated by roxygen2: do not edit by hand +% Please edit documentation in R/bioclim_vars.R +\name{.cv} +\alias{.cv} +\title{Coefficient of variation (expressed as percentage)} +\usage{ +.cv(x) +} +\arguments{ +\item{x}{a vector of values} +} +\value{ +the cv +} +\description{ +R function to compute the coefficient of variation +(expressed as a percentage). If there is only a single value, stats::sd = NA. +However, one could argue that cv =0; and NA may break the code that +receives it. The function returns 0 if the mean is close to zero. +} +\details{ +This is ODD: abs to avoid very small (or zero) mean with e.g. -5:5 +} +\keyword{internal} diff --git a/man/download_chelsa.Rd b/man/download_chelsa.Rd new file mode 100644 index 00000000..31bc815e --- /dev/null +++ b/man/download_chelsa.Rd @@ -0,0 +1,30 @@ +% Generated by roxygen2: do not edit by hand +% Please edit documentation in R/download_chelsa.R +\name{download_chelsa} +\alias{download_chelsa} +\title{Download the CHELSA modern observations.} +\usage{ +download_chelsa(var, res, path = NULL, version = "2.1", ...) +} +\arguments{ +\item{var}{character Valid variables names are "tas", "tasmax","tasmin", and +"prec".} + +\item{path}{character. Path where to download the data to. If left NULL, the data +will be downloaded from the directory returned by \code{\link[=get_data_path]{get_data_path()}}.} +} +\value{ +TRUE if the requested CHELSA variable was downloaded successfully. +} +\description{ +This function downloads monthly variables from the CHELSA 2.1 dataset. +These variables are saved in a format that can be read by +load_chelsa, and easily used for delta downscaling palaeoclimate +observations. +} +\details{ +Note that variables are named differently from WorldClim. "tas" is the mean +temperature ("tavg" in WorldClim), with "tasmax" and "tasmin" being equivalent +to "tmax" and "tmin". +} +\keyword{internal} diff --git a/man/download_dataset.Rd b/man/download_dataset.Rd index 5c33e001..e6357923 100644 --- a/man/download_dataset.Rd +++ b/man/download_dataset.Rd @@ -4,15 +4,20 @@ \alias{download_dataset} \title{Download palaeoclimate reconstructions.} \usage{ -download_dataset(dataset, bio_variables = NULL) +download_dataset(dataset, bio_variables = NULL, annual = TRUE, monthly = FALSE) } \arguments{ \item{dataset}{string defining dataset to be downloaded (a list of possible -values can be obtained with \code{\link[=get_available_datasets]{get_available_datasets()}}). This function +values can be obtained with \code{\link[=list_available_datasets]{list_available_datasets()}}). This function will not work on custom datasets.} \item{bio_variables}{one or more variable names to be downloaded. If left -to NULL, all variables available for this dataset will be downloaded} +to NULL, all variables available for this dataset will be downloaded (the +parameters \code{annual} and \code{monthly}, see below, define which types)} + +\item{annual}{boolean to download annual variables} + +\item{monthly}{boolean to download monthly variables} } \value{ TRUE if the dataset(s) was downloaded correctly. diff --git a/man/download_etopo.Rd b/man/download_etopo.Rd new file mode 100644 index 00000000..102f7b5c --- /dev/null +++ b/man/download_etopo.Rd @@ -0,0 +1,25 @@ +% Generated by roxygen2: do not edit by hand +% Please edit documentation in R/download_etopo.R +\name{download_etopo} +\alias{download_etopo} +\title{Download the ETOPO Global relief model} +\usage{ +download_etopo(path = NULL, resolution = 60) +} +\arguments{ +\item{path}{character. Path where to download the data to. If left NULL, the data +will be downloaded from the directory returned by \code{\link[=get_data_path]{get_data_path()}}, and automatically +named "etopo2022_{resolution}s_v1.nc"} + +\item{resolution}{numeric resolution in arcsecs (one of 30, or 60). +Defaults to 60 arcsecs.} +} +\value{ +a dataframe produced by \code{\link[curl:multi_download]{curl::multi_download()}} with information about +the download (including error codes) +} +\description{ +This function downloads the ETOPO2022 global relief model at 30 or 60 arcsecs +resolution. This is a large file (>1Gb). +} +\keyword{internal} diff --git a/man/download_worldclim_future.Rd b/man/download_worldclim_future.Rd new file mode 100644 index 00000000..c420ff1f --- /dev/null +++ b/man/download_worldclim_future.Rd @@ -0,0 +1,23 @@ +% Generated by roxygen2: do not edit by hand +% Please edit documentation in R/download_worldclim_future.R +\name{download_worldclim_future} +\alias{download_worldclim_future} +\title{Download a WorldClim future predictions.} +\usage{ +download_worldclim_future(dataset, bio_var, filename) +} +\arguments{ +\item{dataset}{the name of the dataset} + +\item{bio_var}{the variable name} + +\item{filename}{the file name (full path) of the file to be saved} +} +\value{ +TRUE if the requested WorldClim variable was downloaded successfully +} +\description{ +This function downloads annual and monthly variables from the WorldClim 2.1 +predictions for the future. +} +\keyword{internal} diff --git a/man/download_worldclim_present.Rd b/man/download_worldclim_present.Rd new file mode 100644 index 00000000..bf44cbc8 --- /dev/null +++ b/man/download_worldclim_present.Rd @@ -0,0 +1,22 @@ +% Generated by roxygen2: do not edit by hand +% Please edit documentation in R/download_worldclim_present.R +\name{download_worldclim_present} +\alias{download_worldclim_present} +\title{Download a WorldClim modern observations.} +\usage{ +download_worldclim_present(dataset, bio_var, filename) +} +\arguments{ +\item{dataset}{the name of the dataset} + +\item{bio_var}{the variable name} + +\item{filename}{the file name (full path) of the file to be saved} +} +\value{ +TRUE if the requested WorldClim variable was downloaded successfully +} +\description{ +This function downloads annual and monthly variables from the WorldClim 2.1 dataset. +} +\keyword{internal} diff --git a/man/get_available_datasets.Rd b/man/get_available_datasets.Rd index 093b9321..ffa35a95 100644 --- a/man/get_available_datasets.Rd +++ b/man/get_available_datasets.Rd @@ -10,6 +10,12 @@ get_available_datasets() a character vector of the available datasets } \description{ -List the datasets available in pastclim. Most functions can also be +List the datasets available in pastclim, which can be passed to functions +in \code{pastclim} as values for the parameter \code{dataset}. Most functions can also be used on custom datasets by setting \code{dataset="custom"} } +\details{ +This function provides a user-friendly list, summarising the many datasets +available from WorldClim. A comprehensive list of all available datasets +can be obtained with \link{list_available_datasets}. +} diff --git a/man/get_biome_classes.Rd b/man/get_biome_classes.Rd index f098efbd..f203c651 100644 --- a/man/get_biome_classes.Rd +++ b/man/get_biome_classes.Rd @@ -8,7 +8,7 @@ get_biome_classes(dataset) } \arguments{ \item{dataset}{string defining dataset to be downloaded (a list of possible -values can be obtained with \code{\link[=get_available_datasets]{get_available_datasets()}}). This function +values can be obtained with \code{\link[=list_available_datasets]{list_available_datasets()}}). This function will not work on custom datasets.} } \value{ diff --git a/man/get_dataset_info.Rd b/man/get_dataset_info.Rd index acc3377c..4c6ec9a3 100644 --- a/man/get_dataset_info.Rd +++ b/man/get_dataset_info.Rd @@ -15,6 +15,6 @@ text describing the dataset \description{ This function provides full information about a given dataset. A full list of datasets available in pastclim can be obtained with -\code{\link[=get_available_datasets]{get_available_datasets()}} +\code{\link[=list_available_datasets]{list_available_datasets()}} } \keyword{internal} diff --git a/man/get_file_for_dataset.Rd b/man/get_file_for_dataset.Rd index 18044a10..ceb41598 100644 --- a/man/get_file_for_dataset.Rd +++ b/man/get_file_for_dataset.Rd @@ -10,7 +10,7 @@ get_file_for_dataset(variable, dataset) \item{variable}{one or more variable names to be downloaded} \item{dataset}{string defining dataset to be downloaded (a list of possible -values can be obtained with \code{\link[=get_available_datasets]{get_available_datasets()}}). This function +values can be obtained with \code{\link[=list_available_datasets]{list_available_datasets()}}). This function will not work on custom datasets.} } \value{ diff --git a/man/get_ice_mask.Rd b/man/get_ice_mask.Rd index daae52f5..a5740606 100644 --- a/man/get_ice_mask.Rd +++ b/man/get_ice_mask.Rd @@ -4,18 +4,25 @@ \alias{get_ice_mask} \title{Get the ice mask for a dataset.} \usage{ -get_ice_mask(time_bp, dataset) +get_ice_mask(time_bp = NULL, dataset) } \arguments{ -\item{time_bp}{time slice in years before present (negative)} +\item{time_bp}{time slices in years before present (negative values represent +time before present, positive values time in the future). This parameter can +be a vector of times (the slices need +to exist in the dataset), a list with a min and max element setting the +range of values, or left to NULL to retrieve all time steps. +To check which slices are available, you can use +\code{\link[=get_time_bp_steps]{get_time_bp_steps()}}.} \item{dataset}{string defining dataset to be downloaded (a list of possible -values can be obtained with \code{\link[=get_available_datasets]{get_available_datasets()}}). This function +values can be obtained with \code{\link[=list_available_datasets]{list_available_datasets()}}). This function will not work on custom datasets.} } \value{ a binary \code{\link[terra:SpatRaster-class]{terra::SpatRaster}} with the ice mask as 1s } \description{ -Get the ice mask for a dataset at a given time point. +Get the ice mask for a dataset, either for the whole series or for specific +time points. } diff --git a/man/get_land_mask.Rd b/man/get_land_mask.Rd index 9c404c27..a18d1f10 100644 --- a/man/get_land_mask.Rd +++ b/man/get_land_mask.Rd @@ -4,18 +4,29 @@ \alias{get_land_mask} \title{Get the land mask for a dataset.} \usage{ -get_land_mask(time_bp, dataset) +get_land_mask(time_bp = NULL, time_ce = NULL, dataset) } \arguments{ -\item{time_bp}{time slice in years before present (negative)} +\item{time_bp}{time slices in years before present (negative values represent +time before present, positive values time in the future). This parameter can +be a vector of times (the slices need +to exist in the dataset), a list with a min and max element setting the +range of values, or left to NULL to retrieve all time steps. +To check which slices are available, you can use +\code{\link[=get_time_bp_steps]{get_time_bp_steps()}}.} + +\item{time_ce}{time in years CE as an alternative to \code{time_bp}.Only one of +\code{time_bp} or \code{time_ce} should be used. For available time slices in years CE, use +\code{\link[=get_time_ce_steps]{get_time_ce_steps()}}.} \item{dataset}{string defining dataset to be downloaded (a list of possible -values can be obtained with \code{\link[=get_available_datasets]{get_available_datasets()}}). This function +values can be obtained with \code{\link[=list_available_datasets]{list_available_datasets()}}). This function will not work on custom datasets.} } \value{ a binary \code{\link[terra:SpatRaster-class]{terra::SpatRaster}} with the land mask as 1s } \description{ -Get the land mask for a dataset at a given time point. +Get the land mask for a dataset, either for the whole series or for specific +time points. } diff --git a/man/get_mis_time_steps.Rd b/man/get_mis_time_steps.Rd index f745d24d..9f314aec 100644 --- a/man/get_mis_time_steps.Rd +++ b/man/get_mis_time_steps.Rd @@ -11,7 +11,7 @@ get_mis_time_steps(mis, dataset, path_to_nc = NULL) \link{mis_boundaries}} \item{dataset}{string defining dataset to be downloaded (a list of possible -values can be obtained with \code{\link[=get_available_datasets]{get_available_datasets()}}). If set to +values can be obtained with \code{\link[=list_available_datasets]{list_available_datasets()}}). If set to "custom", then a single nc file is used from "path_to_nc"} \item{path_to_nc}{the path to the custom nc file containing the palaeoclimate diff --git a/man/get_sea_level.Rd b/man/get_sea_level.Rd new file mode 100644 index 00000000..4c876959 --- /dev/null +++ b/man/get_sea_level.Rd @@ -0,0 +1,20 @@ +% Generated by roxygen2: do not edit by hand +% Please edit documentation in R/get_sea_level.R +\name{get_sea_level} +\alias{get_sea_level} +\title{Get sea level estimate} +\usage{ +get_sea_level(time_bp) +} +\arguments{ +\item{time_bp}{the time of interest} +} +\value{ +a vector of sea levels in meters from present level +} +\description{ +This function returns the estimated sea level from Spratt et al. 2016, using +the long PC1. Sea levels are from contemporary sea level (note that the original +data are with reference to the sea level during the Holocene ~5k year ago). +} +\keyword{internal} diff --git a/man/get_time_steps.Rd b/man/get_time_bp_steps.Rd similarity index 58% rename from man/get_time_steps.Rd rename to man/get_time_bp_steps.Rd index 81960deb..ea4ab0bf 100644 --- a/man/get_time_steps.Rd +++ b/man/get_time_bp_steps.Rd @@ -1,14 +1,20 @@ % Generated by roxygen2: do not edit by hand % Please edit documentation in R/get_time_steps.R -\name{get_time_steps} +\name{get_time_bp_steps} +\alias{get_time_bp_steps} +\alias{get_time_ce_steps} \alias{get_time_steps} \title{Get time steps for a given dataset} \usage{ +get_time_bp_steps(dataset, path_to_nc = NULL) + +get_time_ce_steps(dataset, path_to_nc = NULL) + get_time_steps(dataset, path_to_nc = NULL) } \arguments{ \item{dataset}{string defining dataset to be downloaded (a list of possible -values can be obtained with \code{\link[=get_available_datasets]{get_available_datasets()}}). If set to +values can be obtained with \code{\link[=list_available_datasets]{list_available_datasets()}}). If set to "custom", then a single nc file is used from "path_to_nc"} \item{path_to_nc}{the path to the custom nc file containing the palaeoclimate @@ -16,8 +22,8 @@ reconstructions. All the variables of interest need to be included in this file.} } \value{ -a vector of time steps (in time_bp) +a vector of time steps (in time_bp, or time_ce) } \description{ -Get the time steps (in time_bp) available in a given dataset. +Get the time steps (in time_bp or time_ce) available in a given dataset. } diff --git a/man/get_vars_for_dataset.Rd b/man/get_vars_for_dataset.Rd index 15c778fc..020b81e0 100644 --- a/man/get_vars_for_dataset.Rd +++ b/man/get_vars_for_dataset.Rd @@ -4,17 +4,28 @@ \alias{get_vars_for_dataset} \title{Get a list of variables for a given dataset.} \usage{ -get_vars_for_dataset(dataset, path_to_nc = NULL, details = FALSE) +get_vars_for_dataset( + dataset, + path_to_nc = NULL, + details = FALSE, + annual = TRUE, + monthly = FALSE +) } \arguments{ \item{dataset}{string defining dataset to be downloaded (a list of possible -values can be obtained with \code{\link[=get_available_datasets]{get_available_datasets()}}).} +values can be obtained with \code{\link[=list_available_datasets]{list_available_datasets()}}).} \item{path_to_nc}{the path to the custom nc file containing the palaeoclimate -reconstructions.} +reconstructions. If a custom nc file is given, 'details', 'annual' and 'monthly' +are ignored} \item{details}{boolean determining whether the output should include information -including long names of variables and their units} +including long names of variables and their units.} + +\item{annual}{boolean to show annual variables} + +\item{monthly}{boolean to show monthly variables} } \value{ a vector of variable names diff --git a/man/is_region_series.Rd b/man/is_region_series.Rd index 64c39e6c..98843940 100644 --- a/man/is_region_series.Rd +++ b/man/is_region_series.Rd @@ -22,8 +22,9 @@ sub-dataset is a variable, and all variables have the same number of time steps. } \details{ -The standard test only checks that each SpatRaster has the same number of -layers. The more thorough test (obtained with strict=TRUE) actually checks -that all time steps are identical by comparing the result of -\code{\link[terra:time]{terra::time()}} applied to each variable +The standard test only checks that all sub-datasets (each of which is a +\code{\link[terra:SpatRaster-class]{terra::SpatRaster}}) have the same number of +layers. The more thorough test (obtained with \emph{strict=TRUE}) actually checks +that all variables have the same identical time steps by comparing the result of +\code{\link[terra:time]{terra::time()}} applied to each variable. } diff --git a/man/list_available_datasets.Rd b/man/list_available_datasets.Rd new file mode 100644 index 00000000..5660b97a --- /dev/null +++ b/man/list_available_datasets.Rd @@ -0,0 +1,17 @@ +% Generated by roxygen2: do not edit by hand +% Please edit documentation in R/list_available_datasets.R +\name{list_available_datasets} +\alias{list_available_datasets} +\title{List all the available datasets.} +\usage{ +list_available_datasets() +} +\value{ +a character vector of the available datasets +} +\description{ +List the datasets available in pastclim. The list is comprehensive, +and includes all combinations of models and future scenarios for WorldClim. +For a more user-friendly list, use \code{\link[=get_available_datasets]{get_available_datasets()}}. Most functions can also be +used on custom datasets by setting \code{dataset="custom"} +} diff --git a/man/load_dataset_list.Rd b/man/load_dataset_list.Rd index 72459c14..2f8e15a5 100644 --- a/man/load_dataset_list.Rd +++ b/man/load_dataset_list.Rd @@ -16,7 +16,7 @@ the dataset list This function returns a dataframe with the details for each variable available in every dataset. It defaults to the copy stored within the package, but it checks in case there is an updated version stored as -'data_list.csv' in +'dataset_list_included.csv' in \code{tools::R_user_dir("pastclim","config")}. If the latter is present, the last column, named 'dataset_list_v', provides the version of this table, and the most advanced table is used. diff --git a/man/load_etopo.Rd b/man/load_etopo.Rd new file mode 100644 index 00000000..695df225 --- /dev/null +++ b/man/load_etopo.Rd @@ -0,0 +1,30 @@ +% Generated by roxygen2: do not edit by hand +% Please edit documentation in R/load_etopo.R +\name{load_etopo} +\alias{load_etopo} +\title{Load the ETOPO global relief} +\usage{ +load_etopo(path = NULL, resolution = 60, version = "1") +} +\arguments{ +\item{path}{character. Path where the dataset is stored. If left NULL, the data +will be downloaded from the directory returned by \code{\link[=get_data_path]{get_data_path()}}} + +\item{resolution}{numeric resolution in arcsecs (one of 30, or 60). +Defaults to 60 arcsecs.} + +\item{version}{character or numeric. The ETOPO2022 version number. +Only "1" supported at the moment} +} +\value{ +a \code{\link[terra:SpatRaster-class]{terra::SpatRaster}} of relief +} +\description{ +This function loads previously downloaded ETOPO 2022 global relief dataset, at +30 or 60 arcsec resolution. To save the variables in a compatible +format, use \code{\link[=download_etopo]{download_etopo()}}. +} +\details{ +The function assumes that the file name is \emph{etopo2022_{resolution}s_v1.nc} +} +\keyword{internal} diff --git a/man/location_series.Rd b/man/location_series.Rd index 31b09dea..1a372cd9 100644 --- a/man/location_series.Rd +++ b/man/location_series.Rd @@ -7,6 +7,8 @@ location_series( x, time_bp = NULL, + time_ce = NULL, + coords = NULL, bio_variables, dataset, path_to_nc = NULL, @@ -16,9 +18,9 @@ location_series( ) } \arguments{ -\item{x}{a data.frame with columns \code{longitude}, ranging --180 to 180, and \code{latitude}, from -90 to 90 (and an optional \code{name}), -or a vector of cell numbers.} +\item{x}{a data.frame with columns of x and y coordinates (and an optional \code{name} column), +or a vector of cell numbers. See \code{coords} for standard coordinate names, or +how to use custom ones.} \item{time_bp}{time slices in years before present (negative values represent time before present, positive values time in the future). This parameter can @@ -26,7 +28,16 @@ be a vector of times (the slices need to exist in the dataset), a list with a min and max element setting the range of values, or left to NULL to retrieve all time steps. To check which slices are available, you can use -\code{\link[=get_time_steps]{get_time_steps()}}.} +\code{\link[=get_time_bp_steps]{get_time_bp_steps()}}.} + +\item{time_ce}{time slice in years CE (see \code{time_bp} for options). +For available time slices in years CE, use \code{\link[=get_time_ce_steps]{get_time_ce_steps()}}. +Only one of \code{time_bp} or \code{time_ce} should be used.} + +\item{coords}{a vector of length two giving the names of the "x" and "y" +coordinates, as found in \code{data}. If left to NULL, the function will +try to guess the columns based on standard names \code{c("x", "y")}, \code{c("X","Y")}, +\code{c("longitude", "latitude")}, or \code{c("lon", "lat")}} \item{bio_variables}{vector of names of variables to be extracted.} diff --git a/man/location_slice.Rd b/man/location_slice.Rd index 277b05cb..d1f74b55 100644 --- a/man/location_slice.Rd +++ b/man/location_slice.Rd @@ -7,6 +7,8 @@ location_slice( x, time_bp = NULL, + time_ce = NULL, + coords = NULL, bio_variables, dataset, path_to_nc = NULL, @@ -16,15 +18,25 @@ location_slice( ) } \arguments{ -\item{x}{a data.frame with columns \code{longitude}, ranging --180 to 180, and \code{latitude}, from -90 to 90, plus optional -columns \code{time_bp} and \code{name}. Alternatively, a vector of cell numbers.} +\item{x}{a data.frame with columns x and y coordinates(see \code{coords} for +standard coordinate names, or +how to use custom ones), plus optional +columns \code{time_bp} or \code{time_ce} (depending on the units used) and +\code{name}. Alternatively, a vector of cell numbers.} \item{time_bp}{used if no \code{time_bp} column is present in \code{x}: the dates in years before present (negative values represent time before present, i.e. 1950, positive values time in the future) for each location.} +\item{time_ce}{time in years CE as an alternative to \code{time_bp}.Only one of +\code{time_bp} or \code{time_ce} should be used.} + +\item{coords}{a vector of length two giving the names of the "x" and "y" +coordinates, as found in \code{data}. If left to NULL, the function will +try to guess the columns based on standard names \code{c("x", "y")}, \code{c("X","Y")}, +\code{c("longitude", "latitude")}, or \code{c("lon", "lat")}} + \item{bio_variables}{vector of names of variables to be extracted.} \item{dataset}{string defining the dataset to use. If set to "custom", diff --git a/man/location_slice_from_region_series.Rd b/man/location_slice_from_region_series.Rd new file mode 100644 index 00000000..75749154 --- /dev/null +++ b/man/location_slice_from_region_series.Rd @@ -0,0 +1,68 @@ +% Generated by roxygen2: do not edit by hand +% Please edit documentation in R/location_slice_from_region_series.R +\name{location_slice_from_region_series} +\alias{location_slice_from_region_series} +\title{Extract local climate for one or more locations for a given time slice.} +\usage{ +location_slice_from_region_series( + x, + time_bp = NULL, + time_ce = NULL, + coords = NULL, + region_series, + nn_interpol = TRUE, + buffer = FALSE, + directions = 8 +) +} +\arguments{ +\item{x}{a data.frame with columns x and y coordinates(see \code{coords} for +standard coordinate names, or +how to use custom ones), plus optional +columns \code{time_bp} or \code{time_ce} (depending on the units used) and +\code{name}. Alternatively, a vector of cell numbers.} + +\item{time_bp}{used if no \code{time_bp} column is present in \code{x}: the dates in +years before present (negative +values represent time before present, i.e. 1950, positive values time in the future) +for each location.} + +\item{time_ce}{time in years CE as an alternative to \code{time_bp}. Only one of +\code{time_bp} or \code{time_ce} should be used.} + +\item{coords}{a vector of length two giving the names of the "x" and "y" +coordinates, as found in \code{data}. If left to NULL, the function will +try to guess the columns based on standard names \code{c("x", "y")}, \code{c("X","Y")}, +\code{c("longitude", "latitude")}, or \code{c("lon", "lat")}} + +\item{region_series}{a \code{\link{SpatRasterDataset}} obtained with \code{\link[=region_series]{region_series()}}} + +\item{nn_interpol}{boolean determining whether nearest neighbour +interpolation is used to estimate climate for cells that lack such +information (i.e. they are under water or ice). By default, interpolation is only +performed from the first ring of nearest neighbours; if climate is not +available, NA will be returned for that location. The number of neighbours +can be changed with the argument \code{directions}. \code{nn_interpol} defaults to TRUE.} + +\item{buffer}{boolean determining whether the variable will be returned +as the mean of a buffer around the focal cell. If set to TRUE, it overrides +\code{nn_interpol} (which provides the same estimates as \code{buffer} but only for +locations that are in cells with an NA). The buffer size is determined +by the argument \code{directions}. \code{buffer} defaults to FALSE.} + +\item{directions}{character or matrix to indicate the directions in which +cells are considered connected when using \code{nn_interpol} or \code{buffer}. +The following character values are allowed: "rook" or "4" for the +horizontal and vertical neighbours; "bishop" to get the diagonal neighbours; +"queen" or "8" to get the vertical, horizontal and diagonal neighbours; +or "16" for knight and one-cell queen move neighbours. If directions +is a matrix it should have odd dimensions and have logical (or 0, 1) values.} +} +\value{ +a data.frame with the climatic variables of interest. +} +\description{ +This function extract local climate for a set of locations +at the appropriate times (selecting the closest time slice available for the +specific date associated with each location). +} diff --git a/man/make_binary_mask.Rd b/man/make_binary_mask.Rd new file mode 100644 index 00000000..ad398642 --- /dev/null +++ b/man/make_binary_mask.Rd @@ -0,0 +1,19 @@ +% Generated by roxygen2: do not edit by hand +% Please edit documentation in R/make_binary_mask.R +\name{make_binary_mask} +\alias{make_binary_mask} +\title{Create a binary mask} +\usage{ +make_binary_mask(x) +} +\arguments{ +\item{x}{a \code{\link[terra:SpatRaster-class]{terra::SpatRaster}}} +} +\value{ +a \code{\link[terra:SpatRaster-class]{terra::SpatRaster}} with 0s and 1s +} +\description{ +Create a binary mask from a raster: NAs are converted to 0s, and +any other value to 1. +} +\keyword{internal} diff --git a/man/make_ice_mask.Rd b/man/make_ice_mask.Rd new file mode 100644 index 00000000..e1143b41 --- /dev/null +++ b/man/make_ice_mask.Rd @@ -0,0 +1,29 @@ +% Generated by roxygen2: do not edit by hand +% Please edit documentation in R/make_ice_mask.R +\name{make_ice_mask} +\alias{make_ice_mask} +\title{Downscale an ice mask} +\usage{ +make_ice_mask(ice_mask_low_res, land_mask_high_res, d = c(0.5, 3)) +} +\arguments{ +\item{ice_mask_low_res}{a \code{\link[terra:SpatRaster-class]{terra::SpatRaster}} of the low resolution ice mask +to downscale (e.g. as obtained with \code{\link[=get_ice_mask]{get_ice_mask()}})} + +\item{land_mask_high_res}{a \code{\link[terra:SpatRaster-class]{terra::SpatRaster}} of the land masks at different +times (e.g. as obtained from \code{\link[=make_land_mask]{make_land_mask()}}). The ice mask will be cropped +and matched for the resolution of this land mask.} +} +\value{ +a \code{\link[terra:SpatRaster-class]{terra::SpatRaster}} of the ice mask (1's), with the rest of the +world (sea and land) as NA's +} +\description{ +Downscaling the ice mask presents some issues. The mask is a binary raster, +so any standard downscaling approach will still look very blocky. We can +smooth the contour by applying a Gaussian filter. How strong that filter +should be is very much a matter of personal opinion, as we do not have any +data to compare to. This function attempts to use as sensible default value, +but it is worth exploring alternative values to find a good solution. +} +\keyword{internal} diff --git a/man/make_land_mask.Rd b/man/make_land_mask.Rd new file mode 100644 index 00000000..d9d424f5 --- /dev/null +++ b/man/make_land_mask.Rd @@ -0,0 +1,36 @@ +% Generated by roxygen2: do not edit by hand +% Please edit documentation in R/make_land_mask.R +\name{make_land_mask} +\alias{make_land_mask} +\title{Create a land mask} +\usage{ +make_land_mask(relief_rast, time_bp, sea_level = NULL) +} +\arguments{ +\item{relief_rast}{a \code{\link[terra:SpatRaster-class]{terra::SpatRaster}} with relief} + +\item{time_bp}{the time of interest} + +\item{sea_level}{sea level at the time of interest (if left to NULL, this is +computed using Spratt 2016)} +} +\value{ +a \code{\link[terra:SpatRaster-class]{terra::SpatRaster}} of the land masks (with land as 1's and sea +as NAs), where the layers are different times +} +\description{ +Create a land mask for a given time step. The land mask is based on the simple +logic of moving the ocean up and down given the current relief profile ( +topography+bathymetry, i.e. the elevation both above and below sea level). +Note that this approach ignores any rebound due to changing mass and distribution of +ice sheets. +LIMITATIONS: The land mask will show internal lakes/seas as land, as their level +is unrelated to the general sea level. If you have specific reconstructions +of internal lakes (or want to simply reuse their current extents), you will +have to add them onto the masks generated by this function. Also note that the +land mask does not include ice sheets. This means that some areas that are permanently +covered by ice at the two poles will show up as sea. This means that, for any +reconstruction including Greenland or Antarctica, the resulting land mask will +need to be modified to include the appropriate ice sheets. +} +\keyword{internal} diff --git a/man/mode.Rd b/man/mode.Rd new file mode 100644 index 00000000..d6dad4f1 --- /dev/null +++ b/man/mode.Rd @@ -0,0 +1,19 @@ +% Generated by roxygen2: do not edit by hand +% Please edit documentation in R/location_slice_from_region_series.R +\name{mode} +\alias{mode} +\title{Mode} +\usage{ +mode(x) +} +\arguments{ +\item{x}{a vector} +} +\value{ +the mode +} +\description{ +Find the mode of vector x (note that, if multiple values have the same +frequency, this function simply picks the first occurring one) +} +\keyword{internal} diff --git a/man/pastclim.Rd b/man/pastclim.Rd index 2835de06..6ec9f3fc 100644 --- a/man/pastclim.Rd +++ b/man/pastclim.Rd @@ -3,6 +3,7 @@ \docType{package} \name{pastclim} \alias{pastclim} +\alias{pastclim-package} \title{pastclim} \description{ This \code{R} library is designed to provide an easy way to extract and manipulate palaeoclimate diff --git a/man/region_series.Rd b/man/region_series.Rd index f2ef72f1..e557411a 100644 --- a/man/region_series.Rd +++ b/man/region_series.Rd @@ -6,6 +6,7 @@ \usage{ region_series( time_bp = NULL, + time_ce = NULL, bio_variables, dataset, path_to_nc = NULL, @@ -20,7 +21,11 @@ be a vector of times (the slices need to exist in the dataset), a list with a min and max element setting the range of values, or left to NULL to retrieve all time steps. To check which slices are available, you can use -\code{\link[=get_time_steps]{get_time_steps()}}.} +\code{\link[=get_time_bp_steps]{get_time_bp_steps()}}.} + +\item{time_ce}{time slices in years CE (see \code{time_bp} for options). +For available time slices in years CE, use \code{\link[=get_time_ce_steps]{get_time_ce_steps()}}. +Only one of \code{time_bp} or \code{time_ce} should be used.} \item{bio_variables}{vector of names of variables to be extracted} diff --git a/man/region_slice.Rd b/man/region_slice.Rd index 24079a66..6ce44872 100644 --- a/man/region_slice.Rd +++ b/man/region_slice.Rd @@ -5,7 +5,8 @@ \title{Extract a climate slice for a region} \usage{ region_slice( - time_bp, + time_bp = NULL, + time_ce = NULL, bio_variables, dataset, path_to_nc = NULL, @@ -18,7 +19,11 @@ region_slice( values represent time before present, positive values time in the future). The slice needs to exist in the dataset. To check which slices are available, you can use -\code{\link[=get_time_steps]{get_time_steps()}}.} +\code{\link[=get_time_bp_steps]{get_time_bp_steps()}}.} + +\item{time_ce}{time slice in years CE. +For available time slices in years CE, use \code{\link[=get_time_ce_steps]{get_time_ce_steps()}}. +Only one of \code{time_bp} or \code{time_ce} should be used.} \item{bio_variables}{vector of names of variables to be extracted} diff --git a/man/set_data_path.Rd b/man/set_data_path.Rd index 46d5890e..1aa9d10f 100644 --- a/man/set_data_path.Rd +++ b/man/set_data_path.Rd @@ -8,7 +8,8 @@ set_data_path( path_to_nc = NULL, ask = TRUE, write_config = TRUE, - copy_example = TRUE + copy_example = TRUE, + on_CRAN = FALSE ) } \arguments{ @@ -24,6 +25,10 @@ file} \item{copy_example}{boolean on whether the example dataset should be saved in the data_path} + +\item{on_CRAN}{boolean; users should NOT need this parameters. It is used to set up a +data path in the temporary directory for examples and tests +to run on CRAN.} } \value{ TRUE if the path was set correctly diff --git a/man/set_data_path_for_CRAN.Rd b/man/set_data_path_for_CRAN.Rd deleted file mode 100644 index 5d2ba6fa..00000000 --- a/man/set_data_path_for_CRAN.Rd +++ /dev/null @@ -1,16 +0,0 @@ -% Generated by roxygen2: do not edit by hand -% Please edit documentation in R/set_data_path.R -\name{set_data_path_for_CRAN} -\alias{set_data_path_for_CRAN} -\title{Set the data path for examples on CRAN} -\usage{ -set_data_path_for_CRAN() -} -\value{ -None -} -\description{ -Users should NOT need this function. It is used to set up a -data path in the temporary directory for examples and tests -to run on CRAN. -} diff --git a/man/slice_region_series.Rd b/man/slice_region_series.Rd index 6694e903..de635bf2 100644 --- a/man/slice_region_series.Rd +++ b/man/slice_region_series.Rd @@ -4,17 +4,19 @@ \alias{slice_region_series} \title{Extract a slice for a time series of climate variables for a region} \usage{ -slice_region_series(x, time_bp) +slice_region_series(x, time_bp = NULL, time_ce = NULL) } \arguments{ \item{x}{climate time series generated with \code{\link[=region_series]{region_series()}}} -\item{time_bp}{time slices in years before present (i.e. 1950, negative integers +\item{time_bp}{time slice +in years before present (i.e. 1950, negative integers for values in the past). The slices need to exist in the dataset. To check which slices are available, you -can use \code{time_bp(x[[1]])} (note that you have to use -the \code{\link[=time_bp]{time_bp()}} function on the first element of the \code{\link[terra:SpatRaster-class]{terra::SpatRasterDataset}} object, i.e. on one -of the \code{\link[terra:SpatRaster-class]{terra::SpatRaster}} objects)} +can use \code{time_bp(x)}.} + +\item{time_ce}{time slice in years CE. Only one of \code{time_bp} or \code{time_ce} should +be used.} } \value{ a \link{SpatRaster} of the relevant slice. diff --git a/man/time_bp.Rd b/man/time_bp.Rd index 2822b51f..9d480e06 100644 --- a/man/time_bp.Rd +++ b/man/time_bp.Rd @@ -3,17 +3,23 @@ \name{time_bp} \alias{time_bp} \alias{time_bp,SpatRaster-method} +\alias{time_bp,SpatRasterDataset-method} \alias{time_bp<-} \alias{time_bp<-,SpatRaster-method} -\title{Extract and set time in years before present for SpatRaster} +\alias{time_bp<-,SpatRasterDataset-method} +\title{Extract and set time in years before present for SpatRaster and SpatRasterDataset} \usage{ time_bp(x) \S4method{time_bp}{SpatRaster}(x) +\S4method{time_bp}{SpatRasterDataset}(x) + time_bp(x) <- value \S4method{time_bp}{SpatRaster}(x) <- value + +\S4method{time_bp}{SpatRasterDataset}(x) <- value } \arguments{ \item{x}{a \code{\link[terra:SpatRaster-class]{terra::SpatRaster}}} @@ -25,7 +31,7 @@ a date in years BP (where negative numbers indicate a date in the past) } \description{ This functions extracts and sets time in years BP (i.e. from 1950) for a -\code{\link[terra:SpatRaster-class]{terra::SpatRaster}}. In the \code{\link[terra:SpatRaster-class]{terra::SpatRaster}} object, time is +\code{\link[terra:SpatRaster-class]{terra::SpatRaster}} or a \code{\link[terra:SpatRaster-class]{terra::SpatRasterDataset}}. In a \code{\link[terra:SpatRaster-class]{terra::SpatRaster}} object, time is stored with unit "years", which are years from 0AD. This means that, when a summary of the \code{\link[terra:SpatRaster-class]{terra::SpatRaster}} is diff --git a/man/validate_nc.Rd b/man/validate_nc.Rd index b50dd969..58615a00 100644 --- a/man/validate_nc.Rd +++ b/man/validate_nc.Rd @@ -13,7 +13,7 @@ validate_nc(path_to_nc) TRUE if the file is valid. } \description{ -This function validates a netcdf file as a potential dataset for \code{pastlim}. +This function validates a netcdf file as a potential dataset for \code{pastclim}. The key checks are: a) that the dimensions (longitude, latitude and time) have been set correctly. b) that all variables have the appropriate metadata (longname and units) diff --git a/man/var_labels.Rd b/man/var_labels.Rd index a3ee6dad..388730f5 100644 --- a/man/var_labels.Rd +++ b/man/var_labels.Rd @@ -13,7 +13,7 @@ var_labels(x, dataset, with_units = TRUE, abbreviated = FALSE) [region_slice())]: R:region_slice())} \item{dataset}{string defining dataset to be downloaded (a list of possible -values can be obtained with \code{\link[=get_available_datasets]{get_available_datasets()}}). This function +values can be obtained with \code{\link[=list_available_datasets]{list_available_datasets()}}). This function will not work on custom datasets.} \item{with_units}{boolean defining whether the label should include units} @@ -33,15 +33,17 @@ var_labels("bio01", dataset = "Example") # set the data_path for this example to run on CRAN # users don't need to run this line -set_data_path_for_CRAN() +set_data_path(on_CRAN = TRUE) # for a SpatRaster climate_20k <- region_slice( -time_bp = -20000, -bio_variables = c("bio01", "bio10", "bio12"), -dataset = "Example" + time_bp = -20000, + bio_variables = c("bio01", "bio10", "bio12"), + dataset = "Example" ) terra::plot(climate_20k, main = var_labels(climate_20k, dataset = "Example")) -terra::plot(climate_20k, main = var_labels(climate_20k, dataset = "Example", - abbreviated = TRUE)) +terra::plot(climate_20k, main = var_labels(climate_20k, + dataset = "Example", + abbreviated = TRUE +)) } diff --git a/man/ybp2date.Rd b/man/ybp2date.Rd new file mode 100644 index 00000000..75e96dc6 --- /dev/null +++ b/man/ybp2date.Rd @@ -0,0 +1,31 @@ +% Generated by roxygen2: do not edit by hand +% Please edit documentation in R/ybp2date.R +\name{ybp2date} +\alias{ybp2date} +\alias{date2ybp} +\title{Convert years BP from pastclim to lubridate date, or vice versa} +\usage{ +ybp2date(x) + +date2ybp(x) +} +\arguments{ +\item{x}{a time in years BP using the \code{pastclim} convention of +negative numbers indicating years into the past, or a \code{POSIXct} date object} +} +\value{ +a \code{POSIXct} date object, or a vector +} +\description{ +These functions convert between years BP as used by pastclim (negative +numbers going into +the past, positive into the future) and standard +\code{POSIXct} date objects. +} +\examples{ +ybp2date(-10000) +ybp2date(0) +# back and forth +date2ybp(ybp2date(-10000)) + +} diff --git a/tests/testthat/test_check_dataset_path.R b/tests/testthat/test_check_dataset_path.R index e308a10e..b010eff2 100644 --- a/tests/testthat/test_check_dataset_path.R +++ b/tests/testthat/test_check_dataset_path.R @@ -1,11 +1,13 @@ # set up data path for this test -data_path <- file.path(tempdir(),"pastclim_data") +data_path <- file.path(tempdir(), "pastclim_data") unlink(data_path, recursive = TRUE) # it should not exist, but remove it just in case # set data path -set_data_path(path_to_nc = data_path, - ask = FALSE, - write_config = FALSE, - copy_example = TRUE) +set_data_path( + path_to_nc = data_path, + ask = FALSE, + write_config = FALSE, + copy_example = TRUE +) ################################################################################ test_that("check_dataset_path errors", { @@ -18,7 +20,7 @@ test_that("check_dataset_path errors", { check_dataset_path("custom", NULL), "you need to set path_to_nc if dataset='custom'" ) - example_filename <- getOption("pastclim.dataset_list")$file_name[getOption("pastclim.dataset_list")$dataset=="Example"][1] + example_filename <- getOption("pastclim.dataset_list")$file_name[getOption("pastclim.dataset_list")$dataset == "Example"][1] expect_true(check_dataset_path( "custom", file.path( @@ -41,4 +43,3 @@ test_that("check_dataset_path errors", { ################################################################################ # clean up for the next test unlink(data_path, recursive = TRUE) - diff --git a/tests/testthat/test_check_time_vars.R b/tests/testthat/test_check_time_vars.R new file mode 100644 index 00000000..def6590f --- /dev/null +++ b/tests/testthat/test_check_time_vars.R @@ -0,0 +1,31 @@ +test_that("check_time_vars", { + time_bp <- c(-1000, -20000, 250) + time_ce <- c(1950, 0, -10000) + expect_error( + check_time_vars(time_bp = time_bp, time_ce = time_ce), + "both time_bp and time_ce" + ) + expect_identical( + check_time_vars(time_bp = time_bp, time_ce = NULL), + time_bp + ) + expect_identical( + check_time_vars(time_bp = NULL, time_ce = time_ce), + time_ce - 1950 + ) + expect_identical( + check_time_vars( + time_bp = NULL, + time_ce = list(min = -11050, max = 1950) + ), + list(min = -13000, max = 0) + ) + + + # deal with both null + expect_null(check_time_vars(time_bp = NULL, time_ce = NULL)) + expect_error(check_time_vars( + time_bp = NULL, time_ce = NULL, + allow_null = FALSE + ), "either time_bp or time_ce should be provided") +}) diff --git a/tests/testthat/test_clean_data_path.R b/tests/testthat/test_clean_data_path.R index 78b81ff8..510763a1 100644 --- a/tests/testthat/test_clean_data_path.R +++ b/tests/testthat/test_clean_data_path.R @@ -1,31 +1,33 @@ # set up data path for this test -data_path <- file.path(tempdir(),"pastclim_data") +data_path <- file.path(tempdir(), "pastclim_data") unlink(data_path, recursive = TRUE) # it should not exist, but remove it just in case # set data path -set_data_path(path_to_nc = data_path, - ask = FALSE, - write_config = FALSE, - copy_example = TRUE) +set_data_path( + path_to_nc = data_path, + ask = FALSE, + write_config = FALSE, + copy_example = TRUE +) ################################################################################ test_that("clean data path", { files_in_data_path <- list.files(get_data_path()) - expect_message(clean_data_path(ask = FALSE), - "Everything is") + expect_message( + clean_data_path(ask = FALSE), + "Everything is" + ) # the files should not be touched - expect_equal(files_in_data_path,list.files(get_data_path())) + expect_equal(files_in_data_path, list.files(get_data_path())) # now create a spurious file file_to_add <- "example_climate_v0.0.1.nc" - write.csv("blash",file.path(get_data_path(),file_to_add)) + write.csv("blash", file.path(get_data_path(), file_to_add)) # now the extra file is there expect_true(file_to_add %in% list.files(get_data_path())) expect_true(clean_data_path(ask = FALSE)) # now it's gone expect_false(file_to_add %in% list.files(get_data_path())) - }) ################################################################################ # clean up for the next test unlink(data_path, recursive = TRUE) - diff --git a/tests/testthat/test_df_from_region_series.R b/tests/testthat/test_df_from_region_series.R index 9f27f1e9..8f36e00d 100644 --- a/tests/testthat/test_df_from_region_series.R +++ b/tests/testthat/test_df_from_region_series.R @@ -1,20 +1,22 @@ # set up data path for this test -data_path <- file.path(tempdir(),"pastclim_data") +data_path <- file.path(tempdir(), "pastclim_data") unlink(data_path, recursive = TRUE) # it should not exist, but remove it just in case # set data path -set_data_path(path_to_nc = data_path, - ask = FALSE, - write_config = FALSE, - copy_example = TRUE) +set_data_path( + path_to_nc = data_path, + ask = FALSE, + write_config = FALSE, + copy_example = TRUE +) ################################################################################ test_that("get df from region series", { x <- region_series( - time_bp = list(min=-15000,max=0), c("bio01", "bio10", "bio12"), - "Example" + time_bp = list(min = -15000, max = 0), bio_variables = c("bio01", "bio10", "bio12"), + dataset = "Example" ) - df_series <- df_from_region_series(x ,xy=TRUE) - expect_true(length(unique(df_series$time_bp))==4) + df_series <- df_from_region_series(x, xy = TRUE) + expect_true(length(unique(df_series$time_bp)) == 4) }) ################################################################################ diff --git a/tests/testthat/test_df_from_region_slice.R b/tests/testthat/test_df_from_region_slice.R index 38cff6ac..bd9da81a 100644 --- a/tests/testthat/test_df_from_region_slice.R +++ b/tests/testthat/test_df_from_region_slice.R @@ -1,24 +1,29 @@ # set up data path for this test -data_path <- file.path(tempdir(),"pastclim_data") +data_path <- file.path(tempdir(), "pastclim_data") unlink(data_path, recursive = TRUE) # it should not exist, but remove it just in case # set data path -set_data_path(path_to_nc = data_path, - ask = FALSE, - write_config = FALSE, - copy_example = TRUE) +set_data_path( + path_to_nc = data_path, + ask = FALSE, + write_config = FALSE, + copy_example = TRUE +) ################################################################################ test_that("get df from region slice", { x <- region_slice( - time_bp = -10000, c("bio01", "bio10", "bio12"), - "Example" + time_bp = -10000, + bio_variables = c("bio01", "bio10", "bio12"), + dataset = "Example" ) df_slice <- df_from_region_slice(x) - expect_true(all(c("x","y") %in% names(df_slice))) - df_slice <- df_from_region_slice(x, xy=FALSE) - expect_false(all(c("x","y") %in% names(df_slice))) - expect_error(df_from_region_slice("foo", xy=FALSE), - "x is not a valid SpatRaster ") + expect_true(all(c("x", "y") %in% names(df_slice))) + df_slice <- df_from_region_slice(x, xy = FALSE) + expect_false(all(c("x", "y") %in% names(df_slice))) + expect_error( + df_from_region_slice("foo", xy = FALSE), + "x is not a valid SpatRaster " + ) }) ################################################################################ diff --git a/tests/testthat/test_distance_from_sea.R b/tests/testthat/test_distance_from_sea.R index ca75f618..304375eb 100644 --- a/tests/testthat/test_distance_from_sea.R +++ b/tests/testthat/test_distance_from_sea.R @@ -1,25 +1,34 @@ # set up data path for this test -data_path <- file.path(tempdir(),"pastclim_data") +data_path <- file.path(tempdir(), "pastclim_data") unlink(data_path, recursive = TRUE) # it should not exist, but remove it just in case # set data path -set_data_path(path_to_nc = data_path, - ask = FALSE, - write_config = FALSE, - copy_example = TRUE) +set_data_path( + path_to_nc = data_path, + ask = FALSE, + write_config = FALSE, + copy_example = TRUE +) ################################################################################ testthat::test_that("get biome classes", { - distance_spatrast <- distance_from_sea(time_bp=-10000, - dataset="Example") + distance_spatrast <- distance_from_sea( + time_bp = -10000, + dataset = "Example" + ) # check that we have distances for land only for the correct landmask - correct_landmask <- get_land_mask(time_bp=-10000, - dataset="Example") + correct_landmask <- get_land_mask( + time_bp = -10000, + dataset = "Example" + ) expect_true(all(is.na(distance_spatrast[is.na(correct_landmask)]))) - wrong_landmask <- get_land_mask(time_bp=-20000, - dataset="Example") + wrong_landmask <- get_land_mask( + time_bp = -20000, + dataset = "Example" + ) expect_false(all(is.na(distance_spatrast[is.na(wrong_landmask)]))) - - + # now get them all + distance_spatrast <- distance_from_sea(dataset = "Example") + expect_true(all(time_bp(distance_spatrast) == get_time_bp_steps(dataset = "Example"))) }) ################################################################################ diff --git a/tests/testthat/test_download_dataset.R b/tests/testthat/test_download_dataset.R index 6646ffb2..5f57b74d 100644 --- a/tests/testthat/test_download_dataset.R +++ b/tests/testthat/test_download_dataset.R @@ -1,17 +1,19 @@ # set up data path for this test -data_path <- file.path(tempdir(),"pastclim_data") +data_path <- file.path(tempdir(), "pastclim_data") unlink(data_path, recursive = TRUE) # it should not exist, but remove it just in case # set data path -set_data_path(path_to_nc = data_path, - ask = FALSE, - write_config = FALSE, - copy_example = TRUE) +set_data_path( + path_to_nc = data_path, + ask = FALSE, + write_config = FALSE, + copy_example = TRUE +) ################################################################################ test_that("download_dataset", { expect_error( download_dataset("Beyer"), - "'dataset' must be one of " + "Invalid 'dataset'," ) expect_error( download_dataset("Beyer2020", @@ -20,7 +22,7 @@ test_that("download_dataset", { "^foo not available " ) # check that only the example climate is in the data directory - example_filename <- getOption("pastclim.dataset_list")$file_name[getOption("pastclim.dataset_list")$dataset=="Example"][1] + example_filename <- getOption("pastclim.dataset_list")$file_name[getOption("pastclim.dataset_list")$dataset == "Example"][1] expect_true(example_filename %in% list.files(get_data_path())) # expect no error as the dataset exists expect_error(download_dataset("Example"), NA) @@ -29,4 +31,3 @@ test_that("download_dataset", { ################################################################################ # clean up for the next test unlink(data_path, recursive = TRUE) - diff --git a/tests/testthat/test_get_available_dataset.R b/tests/testthat/test_get_available_dataset.R index 4561b4f4..d71705ea 100644 --- a/tests/testthat/test_get_available_dataset.R +++ b/tests/testthat/test_get_available_dataset.R @@ -1,26 +1,30 @@ # set up data path for this test -data_path <- file.path(tempdir(),"pastclim_data") +data_path <- file.path(tempdir(), "pastclim_data") unlink(data_path, recursive = TRUE) # it should not exist, but remove it just in case # set data path -set_data_path(path_to_nc = data_path, - ask = FALSE, - write_config = FALSE, - copy_example = TRUE) +set_data_path( + path_to_nc = data_path, + ask = FALSE, + write_config = FALSE, + copy_example = TRUE +) ################################################################################ testthat::test_that("get_and_check_available_datasets", { - testthat::expect_true(all(get_available_datasets() %in% c( + testthat::expect_true(all(c( + "Barreto2023", "Beyer2020", "Krapp2021", "Example" - ))) + ) %in% list_available_datasets())) testthat::expect_true(check_available_dataset("Example")) testthat::expect_error( check_available_dataset("foo"), "'dataset' must be one of " ) testthat::expect_true(check_available_dataset("custom", - include_custom = TRUE)) + include_custom = TRUE + )) testthat::expect_error( check_available_dataset("custom"), "'dataset' must be one of " diff --git a/tests/testthat/test_get_biome_classes.R b/tests/testthat/test_get_biome_classes.R index f19078dd..8b1f9749 100644 --- a/tests/testthat/test_get_biome_classes.R +++ b/tests/testthat/test_get_biome_classes.R @@ -1,11 +1,13 @@ # set up data path for this test -data_path <- file.path(tempdir(),"pastclim_data") +data_path <- file.path(tempdir(), "pastclim_data") unlink(data_path, recursive = TRUE) # it should not exist, but remove it just in case # set data path -set_data_path(path_to_nc = data_path, - ask = FALSE, - write_config = FALSE, - copy_example = TRUE) +set_data_path( + path_to_nc = data_path, + ask = FALSE, + write_config = FALSE, + copy_example = TRUE +) ################################################################################ testthat::test_that("get biome classes", { diff --git a/tests/testthat/test_get_downloaded_datasets.R b/tests/testthat/test_get_downloaded_datasets.R index 988384cc..d36ab211 100644 --- a/tests/testthat/test_get_downloaded_datasets.R +++ b/tests/testthat/test_get_downloaded_datasets.R @@ -1,11 +1,13 @@ # set up data path for this test -data_path <- file.path(tempdir(),"pastclim_data") +data_path <- file.path(tempdir(), "pastclim_data") unlink(data_path, recursive = TRUE) # it should not exist, but remove it just in case # set data path -set_data_path(path_to_nc = data_path, - ask = FALSE, - write_config = FALSE, - copy_example = TRUE) +set_data_path( + path_to_nc = data_path, + ask = FALSE, + write_config = FALSE, + copy_example = TRUE +) ################################################################################ diff --git a/tests/testthat/test_get_file_for_dataset.R b/tests/testthat/test_get_file_for_dataset.R index 2784a294..1cbe9580 100644 --- a/tests/testthat/test_get_file_for_dataset.R +++ b/tests/testthat/test_get_file_for_dataset.R @@ -1,11 +1,13 @@ # set up data path for this test -data_path <- file.path(tempdir(),"pastclim_data") +data_path <- file.path(tempdir(), "pastclim_data") unlink(data_path, recursive = TRUE) # it should not exist, but remove it just in case # set data path -set_data_path(path_to_nc = data_path, - ask = FALSE, - write_config = FALSE, - copy_example = TRUE) +set_data_path( + path_to_nc = data_path, + ask = FALSE, + write_config = FALSE, + copy_example = TRUE +) ################################################################################ test_that("get_file_for_dataset", { diff --git a/tests/testthat/test_get_ice_mask.R b/tests/testthat/test_get_ice_mask.R new file mode 100644 index 00000000..1a208035 --- /dev/null +++ b/tests/testthat/test_get_ice_mask.R @@ -0,0 +1,33 @@ +# set up data path for this test +data_path <- file.path(tempdir(), "pastclim_data") +unlink(data_path, recursive = TRUE) # it should not exist, but remove it just in case +# set data path +set_data_path( + path_to_nc = data_path, + ask = FALSE, + write_config = FALSE, + copy_example = TRUE +) +################################################################################ + +testthat::test_that("get ice mask", { + # get multiple times + my_times <- c(-10000, 0) + this_mask <- get_ice_mask(time_bp = my_times, dataset = "Example") + expect_true(terra::nlyr(this_mask) == 2) + expect_true(all(time_bp(this_mask) == my_times)) + # get single time + my_times <- c(-20000) + this_mask <- get_ice_mask(time_bp = my_times, dataset = "Example") + expect_true(terra::nlyr(this_mask) == 1) + expect_true(all(time_bp(this_mask) == my_times)) + # full series + this_mask <- get_ice_mask(dataset = "Example") + expect_true(all(time_bp(this_mask) == get_time_bp_steps(dataset = "Example"))) + # incorrect dataset + expect_error(get_ice_mask(dataset = "blah"), "this function only works") +}) + +################################################################################ +# clean up for the next test +unlink(data_path, recursive = TRUE) diff --git a/tests/testthat/test_get_land_mask.R b/tests/testthat/test_get_land_mask.R new file mode 100644 index 00000000..9c7e61ba --- /dev/null +++ b/tests/testthat/test_get_land_mask.R @@ -0,0 +1,33 @@ +# set up data path for this test +data_path <- file.path(tempdir(), "pastclim_data") +unlink(data_path, recursive = TRUE) # it should not exist, but remove it just in case +# set data path +set_data_path( + path_to_nc = data_path, + ask = FALSE, + write_config = FALSE, + copy_example = TRUE +) +################################################################################ + +testthat::test_that("get land mask", { + # get multiple times + my_times <- c(-10000, 0) + this_mask <- get_land_mask(time_bp = my_times, dataset = "Example") + expect_true(terra::nlyr(this_mask) == 2) + expect_true(all(time_bp(this_mask) == my_times)) + # get single time + my_times <- c(-20000) + this_mask <- get_land_mask(time_bp = my_times, dataset = "Example") + expect_true(terra::nlyr(this_mask) == 1) + expect_true(all(time_bp(this_mask) == my_times)) + # full series + this_mask <- get_land_mask(dataset = "Example") + expect_true(all(time_bp(this_mask) == get_time_bp_steps(dataset = "Example"))) + # incorrect dataset + expect_error(get_land_mask(dataset = "blah"), "this function only works") +}) + +################################################################################ +# clean up for the next test +unlink(data_path, recursive = TRUE) diff --git a/tests/testthat/test_get_mis_time_steps.R b/tests/testthat/test_get_mis_time_steps.R index 3f219dd3..99ed2295 100644 --- a/tests/testthat/test_get_mis_time_steps.R +++ b/tests/testthat/test_get_mis_time_steps.R @@ -1,11 +1,13 @@ # set up data path for this test -data_path <- file.path(tempdir(),"pastclim_data") +data_path <- file.path(tempdir(), "pastclim_data") unlink(data_path, recursive = TRUE) # it should not exist, but remove it just in case # set data path -set_data_path(path_to_nc = data_path, - ask = FALSE, - write_config = FALSE, - copy_example = TRUE) +set_data_path( + path_to_nc = data_path, + ask = FALSE, + write_config = FALSE, + copy_example = TRUE +) ################################################################################ test_that("get_mis_time_steps for standard dataset", { @@ -16,16 +18,17 @@ test_that("get_mis_time_steps for standard dataset", { }) test_that("get_mis_time_steps for local file", { - example_filename <- getOption("pastclim.dataset_list")$file_name[getOption("pastclim.dataset_list")$dataset=="Example"][1] + example_filename <- getOption("pastclim.dataset_list")$file_name[getOption("pastclim.dataset_list")$dataset == "Example"][1] path_to_example_nc <- system.file("/extdata/", example_filename, package = "pastclim" ) - expect_equal(get_mis_time_steps( - mis = "2", dataset = "custom", - path_to_nc = path_to_example_nc - ), - c(-20000, -15000), - ignore_attr = TRUE + expect_equal( + get_mis_time_steps( + mis = "2", dataset = "custom", + path_to_nc = path_to_example_nc + ), + c(-20000, -15000), + ignore_attr = TRUE ) }) diff --git a/tests/testthat/test_get_set_data_path.R b/tests/testthat/test_get_set_data_path.R index c8ae92be..fc9daf16 100644 --- a/tests/testthat/test_get_set_data_path.R +++ b/tests/testthat/test_get_set_data_path.R @@ -5,7 +5,7 @@ test_that("get data path when config not present", { skip_if((file.exists(file.path( tools::R_user_dir("pastclim", "config"), "pastclim_data.txt" - ))),"config file already exists on this system") + ))), "config file already exists on this system") # try to get path when none is set expect_message(null_data_path <- get_data_path()) expect_null(null_data_path) @@ -16,34 +16,40 @@ test_that("get data path when config not present", { test_that("set and get data path", { # now set the path in a subdirectory of tempdir - data_path <- file.path(tempdir(),"pastclim_data") + data_path <- file.path(tempdir(), "pastclim_data") unlink(data_path, recursive = TRUE) # it should not exist, but remove it just in case # set data path - expect_true(set_data_path(path_to_nc = data_path, - ask = FALSE, - write_config = FALSE, - copy_example = FALSE)) - expect_equal(get_data_path(), data_path) + expect_true(set_data_path( + path_to_nc = data_path, + ask = FALSE, + write_config = FALSE, + copy_example = FALSE + )) + expect_equal(normalizePath(get_data_path()), normalizePath(data_path)) unlink(data_path, recursive = TRUE) # clean up options(pastclim.data_path = NULL) # reset the option - + # use dir with spaces (as it is the case for the default data dir on MacOS) - data_path <- file.path(tempdir(),"/Users/pkgbuilds/Library/Application Support/org.R-project.R/R/pastclim") + data_path <- file.path(tempdir(), "/Users/pkgbuilds/Library/Application Support/org.R-project.R/R/pastclim") unlink(data_path, recursive = TRUE) # it should not exist, but remove it just in case - expect_true(set_data_path(path_to_nc = data_path, - ask = FALSE, - write_config = FALSE, - copy_example = FALSE)) - expect_equal(get_data_path(), data_path) + expect_true(set_data_path( + path_to_nc = data_path, + ask = FALSE, + write_config = FALSE, + copy_example = FALSE + )) + expect_equal(normalizePath(get_data_path()), normalizePath(data_path)) # this should be empty - expect_true(length(dir(data_path)) ==0) + expect_true(length(dir(data_path)) == 0) # now copy the data files options(pastclim.data_path = NULL) # reset the option - - expect_true(set_data_path(path_to_nc = data_path, - ask = FALSE, - write_config = FALSE, - copy_example = TRUE)) + + expect_true(set_data_path( + path_to_nc = data_path, + ask = FALSE, + write_config = FALSE, + copy_example = TRUE + )) # there should be a file now expect_true(length(dir(data_path)) == 1) unlink(data_path, recursive = TRUE) # clean up diff --git a/tests/testthat/test_get_time_steps.R b/tests/testthat/test_get_time_steps.R index d9c18d14..bb2bffd8 100644 --- a/tests/testthat/test_get_time_steps.R +++ b/tests/testthat/test_get_time_steps.R @@ -1,49 +1,53 @@ # set up data path for this test -data_path <- file.path(tempdir(),"pastclim_data") +data_path <- file.path(tempdir(), "pastclim_data") unlink(data_path, recursive = TRUE) # it should not exist, but remove it just in case # set data path -set_data_path(path_to_nc = data_path, - ask = FALSE, - write_config = FALSE, - copy_example = TRUE) +set_data_path( + path_to_nc = data_path, + ask = FALSE, + write_config = FALSE, + copy_example = TRUE +) ################################################################################ -test_that("get_time_steps requires correct variables", { +test_that("get_time_bp_steps requires correct variables", { expect_error( - get_time_steps(dataset = "blah"), + get_time_bp_steps(dataset = "blah"), "'dataset' must be one of " ) expect_error( - get_time_steps(dataset = "Example", path_to_nc = "blah"), + get_time_bp_steps(dataset = "Example", path_to_nc = "blah"), "path_to_nc can only be set if" ) }) -test_that("get_time_steps for standard dataset", { - expect_equal(get_time_steps(dataset = "Example"), +test_that("get_time_bp_steps for standard dataset", { + expect_equal(get_time_bp_steps(dataset = "Example"), c(-20000, -15000, -10000, -5000, 0), ignore_attr = TRUE ) }) -test_that("get_time_steps for local file", { - example_filename <- getOption("pastclim.dataset_list")$file_name[getOption("pastclim.dataset_list")$dataset=="Example"][1] +test_that("get_time_bp_steps for local file", { + example_filename <- getOption("pastclim.dataset_list")$file_name[getOption("pastclim.dataset_list")$dataset == "Example"][1] path_to_example_nc <- system.file("/extdata/", example_filename, - package = "pastclim" + package = "pastclim" ) - expect_equal(get_time_steps( - dataset = "custom", - path_to_nc = path_to_example_nc - ), - c(-20000, -15000, -10000, -5000, 0), - ignore_attr = TRUE + expect_equal( + get_time_bp_steps( + dataset = "custom", + path_to_nc = path_to_example_nc + ), + c(-20000, -15000, -10000, -5000, 0), + ignore_attr = TRUE ) - expect_equal(get_mis_time_steps( - mis = "2", dataset = "custom", - path_to_nc = path_to_example_nc - ), - c(-20000, -15000), - ignore_attr = TRUE + expect_equal( + get_mis_time_steps( + mis = "2", dataset = "custom", + path_to_nc = path_to_example_nc + ), + c(-20000, -15000), + ignore_attr = TRUE ) }) diff --git a/tests/testthat/test_get_vars_for_dataset.R b/tests/testthat/test_get_vars_for_dataset.R index 11638447..09eab562 100644 --- a/tests/testthat/test_get_vars_for_dataset.R +++ b/tests/testthat/test_get_vars_for_dataset.R @@ -1,11 +1,13 @@ # set up data path for this test -data_path <- file.path(tempdir(),"pastclim_data") +data_path <- file.path(tempdir(), "pastclim_data") unlink(data_path, recursive = TRUE) # it should not exist, but remove it just in case # set data path -set_data_path(path_to_nc = data_path, - ask = FALSE, - write_config = FALSE, - copy_example = TRUE) +set_data_path( + path_to_nc = data_path, + ask = FALSE, + write_config = FALSE, + copy_example = TRUE +) ################################################################################ test_that("get_vars_for_dataset give appropriate errors", { @@ -25,23 +27,27 @@ test_that("get_vars_for_dataset give appropriate errors", { test_that("get_vars_for_dataset returns appropriate object", { vars <- get_vars_for_dataset(dataset = "Example") - expect_true(inherits(vars,"character")) - vars <- get_vars_for_dataset(dataset = "Example", - details = TRUE) - expect_true(inherits(vars,"data.frame")) + expect_true(inherits(vars, "character")) + vars <- get_vars_for_dataset( + dataset = "Example", + details = TRUE + ) + expect_true(inherits(vars, "data.frame")) }) test_that("get_vars_for_dataset for local file", { - example_filename <- getOption("pastclim.dataset_list")$file_name[getOption("pastclim.dataset_list")$dataset=="Example"][1] + example_filename <- getOption("pastclim.dataset_list")$file_name[getOption("pastclim.dataset_list")$dataset == "Example"][1] path_to_example_nc <- system.file("/extdata/", example_filename, - package = "pastclim" + package = "pastclim" ) vars <- get_vars_for_dataset(dataset = "custom", path_to_nc = path_to_example_nc) - expect_true(inherits(vars,"character")) - vars <- get_vars_for_dataset(dataset = "custom", path_to_nc = path_to_example_nc, - details = TRUE) - expect_true(inherits(vars,"data.frame")) + expect_true(inherits(vars, "character")) + vars <- get_vars_for_dataset( + dataset = "custom", path_to_nc = path_to_example_nc, + details = TRUE + ) + expect_true(inherits(vars, "data.frame")) }) ################################################################################ diff --git a/tests/testthat/test_is_region_series.R b/tests/testthat/test_is_region_series.R index 4b93340b..1bc2b6bb 100644 --- a/tests/testthat/test_is_region_series.R +++ b/tests/testthat/test_is_region_series.R @@ -1,48 +1,53 @@ # set up data path for this test -data_path <- file.path(tempdir(),"pastclim_data") +data_path <- file.path(tempdir(), "pastclim_data") unlink(data_path, recursive = TRUE) # it should not exist, but remove it just in case # set data path -set_data_path(path_to_nc = data_path, - ask = FALSE, - write_config = FALSE, - copy_example = TRUE) +set_data_path( + path_to_nc = data_path, + ask = FALSE, + write_config = FALSE, + copy_example = TRUE +) ################################################################################ test_that("is_region_series returns correct values", { climate_region <- region_series( - time_bp = list(min=-15000,max=0), c("bio01", "bio10", "bio12"), - "Example" + time_bp = list(min = -15000, max = 0), + bio_variables = c("bio01", "bio10", "bio12"), + dataset = "Example" ) expect_true(is_region_series(climate_region)) expect_true(is_region_series(climate_region, strict = TRUE)) # change the time for one variable - time(climate_region[1], tstep="years")<-c(1,2,3,4) + time(climate_region[1], tstep = "years") <- c(1, 2, 3, 4) # the simple test should still pass, but the strict test should not expect_true(is_region_series(climate_region)) expect_false(is_region_series(climate_region, strict = TRUE)) # now remove a time step (all tests should fail) climate_region <- region_series( - time_bp = list(min=-15000,max=0), c("bio01", "bio10", "bio12"), - "Example" + time_bp = list(min = -15000, max = 0), + bio_variables = c("bio01", "bio10", "bio12"), + dataset = "Example" ) climate_region[1] <- climate_region[1][[1:3]] expect_false(is_region_series(climate_region)) expect_false(is_region_series(climate_region, strict = TRUE)) - + # now give it a slice europe_climate_20k <- region_slice( time_bp = -20000, - c("bio01", "bio10", "bio12"), + bio_variables = c("bio01", "bio10", "bio12"), dataset = "Example", ext = region_extent$Europe ) - expect_error(is_region_series(europe_climate_20k), - "x should be a SpatRasterDataset") + expect_error( + is_region_series(europe_climate_20k), + "x should be a SpatRasterDataset" + ) }) ################################################################################ # clean up for the next test unlink(data_path, recursive = TRUE) - diff --git a/tests/testthat/test_load_dataset_list.R b/tests/testthat/test_load_dataset_list.R index 849eea82..d0471f3b 100644 --- a/tests/testthat/test_load_dataset_list.R +++ b/tests/testthat/test_load_dataset_list.R @@ -1,31 +1,29 @@ # set up data path for this test -data_path <- file.path(tempdir(),"pastclim_data") +data_path <- file.path(tempdir(), "pastclim_data") unlink(data_path, recursive = TRUE) # it should not exist, but remove it just in case # set data path -set_data_path(path_to_nc = data_path, - ask = FALSE, - write_config = FALSE, - copy_example = TRUE) +set_data_path( + path_to_nc = data_path, + ask = FALSE, + write_config = FALSE, + copy_example = TRUE +) ################################################################################ test_that("load_dataset_list", { - # check that the version returned by load_dataset is the default on - expect_identical(load_dataset_list(on_cran=TRUE)$dataset_list_v[1], - utils::read.csv(system.file("extdata/dataset_list_included.csv", - package="pastclim"))$dataset_list_v[1]) # now create a file in the tempdir - new_table <- utils::read.csv(system.file("extdata/dataset_list_included.csv", - package="pastclim")) + new_table <- load_dataset_list(on_cran = TRUE) # now update to the version - new_table$dataset_list_v[1]<-"99.0.0" - + new_table$dataset_list_v[1] <- "99.0.0" + write.csv(new_table, - file.path(tempdir(),"dataset_list_included.csv"),row.names = FALSE) - # now check the version - expect_true(load_dataset_list(on_cran=TRUE)$dataset_list_v[1]=="99.0.0") + file.path(tempdir(), "dataset_list_included.csv"), + row.names = FALSE + ) + # now check the version when we reload the dataset + expect_true(load_dataset_list(on_cran = TRUE)$dataset_list_v[1] == "99.0.0") }) ################################################################################ # clean up for the next test unlink(data_path, recursive = TRUE) - diff --git a/tests/testthat/test_location_series.R b/tests/testthat/test_location_series.R index 73b439da..4a158c7b 100644 --- a/tests/testthat/test_location_series.R +++ b/tests/testthat/test_location_series.R @@ -1,16 +1,19 @@ # set up data path for this test -data_path <- file.path(tempdir(),"pastclim_data") +data_path <- file.path(tempdir(), "pastclim_data") unlink(data_path, recursive = TRUE) # it should not exist, but remove it just in case # set data path -set_data_path(path_to_nc = data_path, - ask = FALSE, - write_config = FALSE, - copy_example = TRUE) +set_data_path( + path_to_nc = data_path, + ask = FALSE, + write_config = FALSE, + copy_example = TRUE +) ################################################################################ test_that("location_series", { # using standard dataset - locations <- data.frame(name=c("A","B","C","D"), + locations <- data.frame( + name = c("A", "B", "C", "D"), longitude = c(0, 90, -120, -7), latitude = c(20, 45, 60, 37) ) @@ -20,13 +23,27 @@ test_that("location_series", { dataset = "Example" ) expect_true(nrow(locations_ts) == 20) - + + # now check with arbitrary coordinate names + locations_coords <- locations + names(locations_coords)[c(2, 3)] <- c("x.long", "y.lat") + locations_ts_coords <- location_series( + x = locations_coords, + coords = c("x.long", "y.lat"), + bio_variables = c("bio01", "bio12"), + dataset = "Example" + ) + expect_equal( + locations_ts[, c("bio01", "bio12")], + locations_ts_coords[, c("bio01", "bio12")] + ) + locations_ts <- location_series( x = locations[, c("longitude", "latitude")], - time_bp = c(-20000,-10000,-5000), + time_bp = c(-20000, -10000, -5000), bio_variables = c("bio01", "bio12"), dataset = "Example" - ) + ) expect_true(nrow(locations_ts) == 12) locations_ts <- location_series( @@ -34,7 +51,7 @@ test_that("location_series", { time_bp = list(min = -10000, max = -5000), bio_variables = c("bio01", "bio12"), dataset = "Example" - ) + ) expect_true(nrow(locations_ts) == 8) # test one location only @@ -42,16 +59,16 @@ test_that("location_series", { x = locations[1, c("longitude", "latitude")], bio_variables = c("bio01"), dataset = "Example" - ) - + ) + # test with names locations_ts <- location_series( x = locations, bio_variables = c("bio01", "bio12"), dataset = "Example" ) - expect_true("name"%in%names(locations_ts)) - + expect_true("name" %in% names(locations_ts)) + # now test if we try a variable that is not available expect_error( location_series( @@ -83,18 +100,18 @@ test_that("location_series", { # test if we use a dataframe missing some coordinates expect_error( location_series( - x = locations[, c("longitude","name")], + x = locations[, c("longitude", "name")], bio_variables = c("bio01", "bio12"), dataset = "Example" ), - "x should be a dataframe with" - ) - - + "There are no recognised coordinate columns" + ) + + # now use a custom dataset - example_filename <- getOption("pastclim.dataset_list")$file_name[getOption("pastclim.dataset_list")$dataset=="Example"][1] + example_filename <- getOption("pastclim.dataset_list")$file_name[getOption("pastclim.dataset_list")$dataset == "Example"][1] path_to_example_nc <- system.file("/extdata/", example_filename, - package = "pastclim" + package = "pastclim" ) locations_ts <- location_series( x = locations[, c("longitude", "latitude")], diff --git a/tests/testthat/test_location_slice.R b/tests/testthat/test_location_slice.R index 48feb8a8..36b1f4dc 100644 --- a/tests/testthat/test_location_slice.R +++ b/tests/testthat/test_location_slice.R @@ -1,21 +1,23 @@ # set up data path for this test -data_path <- file.path(tempdir(),"pastclim_data") +data_path <- file.path(tempdir(), "pastclim_data") unlink(data_path, recursive = TRUE) # it should not exist, but remove it just in case # set data path -set_data_path(path_to_nc = data_path, - ask = FALSE, - write_config = FALSE, - copy_example = TRUE) +set_data_path( + path_to_nc = data_path, + ask = FALSE, + write_config = FALSE, + copy_example = TRUE +) ################################################################################ test_that("location_slice", { locations <- data.frame( - name = c("A","B","C","D"), + name = c("A", "B", "C", "D"), longitude = c(0, 90, -120, -9), latitude = c(20, 45, 60, 37), time_bp = c(0, -10000, -20000, -10000) ) - - # using a data frame of locations and a separate vector of + + # using a data frame of locations and a separate vector of this_climate <- location_slice( x = locations[, c("longitude", "latitude")], time_bp = locations$time_bp, bio_variables = c("bio01", "bio12"), @@ -33,21 +35,30 @@ test_that("location_slice", { expect_false(is.na(this_climate[1, "bio01"])) expect_true(is.na(this_climate[3, "bio01"])) expect_false(is.na(this_climate[4, "bio01"])) - + this_climate_buffer <- location_slice( x = locations[, c("longitude", "latitude")], time_bp = locations$time_bp, bio_variables = c("bio01", "bio12"), dataset = "Example", - buffer=TRUE + buffer = TRUE ) expect_false(is.na(this_climate_buffer[1, "bio01"])) expect_true(is.na(this_climate_buffer[3, "bio01"])) expect_false(is.na(this_climate_buffer[4, "bio01"])) # the underwater location should return the same value with nn_interpol and buffer # but the other two values should differ - expect_false(this_climate[1, "bio01"]==this_climate_buffer[1, "bio01"]) - expect_false(this_climate[2, "bio01"]==this_climate_buffer[2, "bio01"]) - expect_true(this_climate[4, "bio01"]==this_climate_buffer[4, "bio01"]) + expect_false(this_climate[1, "bio01"] == this_climate_buffer[1, "bio01"]) + expect_false(this_climate[2, "bio01"] == this_climate_buffer[2, "bio01"]) + expect_true(this_climate[4, "bio01"] == this_climate_buffer[4, "bio01"]) + + # now use biome + this_climate_biome <- location_slice( + x = locations[, c("longitude", "latitude")], + time_bp = locations$time_bp, bio_variables = c("bio01", "bio12", "biome"), + dataset = "Example", nn_interpol = TRUE + ) + # checked value by hand + expect_true(this_climate_biome$biome[4] == 17) # now use the full dataframe for pretty labelling this_climate_df <- location_slice( @@ -55,28 +66,58 @@ test_that("location_slice", { bio_variables = c("bio01", "bio12"), dataset = "Example", nn_interpol = TRUE ) - expect_equal(this_climate_df[,c("bio01","bio12")], - this_climate[,c("bio01","bio12")]) + expect_equal( + this_climate_df[, c("bio01", "bio12")], + this_climate[, c("bio01", "bio12")] + ) + + # check alternative coordinate names + # now use the full dataframe for pretty labelling + locations_coords <- locations + names(locations_coords)[c(2, 3)] <- c("x", "y") + this_climate_coords <- location_slice( + x = locations_coords, + bio_variables = c("bio01", "bio12"), + dataset = "Example", nn_interpol = TRUE + ) + expect_equal( + this_climate_df[, c("bio01", "bio12")], + this_climate_coords[, c("bio01", "bio12")] + ) + + # now set to arbitrary names + names(locations_coords)[c(2, 3)] <- c("x.long", "y.lat") + this_climate_coords <- location_slice( + x = locations_coords, + coords = c("x.long", "y.lat"), + bio_variables = c("bio01", "bio12"), + dataset = "Example", nn_interpol = TRUE + ) + expect_equal( + this_climate_df[, c("bio01", "bio12")], + this_climate_coords[, c("bio01", "bio12")] + ) + # check errors if we don't set up correctly with a dataframe # give time in both x and time_bp expect_error(this_climate_df <- location_slice( x = locations, time_bp = locations$time_bp, bio_variables = c("bio01", "bio12"), dataset = "Example", nn_interpol = TRUE - ) , "times should either be given as a column") - # fail to give time when giving only locations + ), "times should either be given as a column") + # fail to give time when giving only locations expect_error(this_climate_df <- location_slice( x = locations[, c("longitude", "latitude")], bio_variables = c("bio01", "bio12"), dataset = "Example", nn_interpol = TRUE - ) , "missing times: they should either ") + ), "missing times: they should either ") # dataframe with missing coordinates expect_error(this_climate_df <- location_slice( - x = locations[,c("longitude","time_bp")], + x = locations[, c("longitude", "time_bp")], bio_variables = c("bio01", "bio12"), dataset = "Example", nn_interpol = TRUE - ) , "x must have columns latitude and longitude") - + ), "There are no recognised coordinate columns") + # now test if we try a variable that is not available expect_error( location_slice( @@ -106,9 +147,9 @@ test_that("location_slice", { ) # now test a custom dataset - example_filename <- getOption("pastclim.dataset_list")$file_name[getOption("pastclim.dataset_list")$dataset=="Example"][1] + example_filename <- getOption("pastclim.dataset_list")$file_name[getOption("pastclim.dataset_list")$dataset == "Example"][1] path_to_example_nc <- system.file("/extdata/", example_filename, - package = "pastclim" + package = "pastclim" ) this_climate <- location_slice( x = locations[, c("longitude", "latitude")], @@ -153,8 +194,28 @@ test_that("location_slice", { time_bp = locations$time_bp, bio_variables = c("bio01", "bio12"), dataset = "Example", nn_interpol = TRUE ) - expect_true(identical(this_climate[, -c(1:3)], - this_climate_timeoff[, -c(1:3)])) + expect_true(identical( + this_climate[, -c(1:3)], + this_climate_timeoff[, -c(1:3)] + )) + + # now do the same with time_ce + locations_time_ce <- data.frame( + longitude = c(0, 90, -120, -9), latitude = c(20, 45, 60, 37), + time_ce = c(0, -9750, -20375, -10475) + 1950 + ) + this_climate_time_ce <- location_slice( + x = locations_time_ce[, c("longitude", "latitude")], + time_ce = locations_time_ce$time_ce, bio_variables = c("bio01", "bio12"), + dataset = "Example", nn_interpol = TRUE + ) + expect_true(all(this_climate_time_ce$time_ce == this_climate_timeoff$time_bp + 1950)) + # using a data.frame + this_climate_time_ce_df <- location_slice( + x = locations_time_ce, + bio_variables = c("bio01", "bio12"), + dataset = "Example", nn_interpol = TRUE + ) }) ################################################################################ diff --git a/tests/testthat/test_location_slice_from_region_series.R b/tests/testthat/test_location_slice_from_region_series.R new file mode 100644 index 00000000..706cf4ac --- /dev/null +++ b/tests/testthat/test_location_slice_from_region_series.R @@ -0,0 +1,40 @@ +# set up data path for this test +data_path <- file.path(tempdir(), "pastclim_data") +unlink(data_path, recursive = TRUE) # it should not exist, but remove it just in case +# set data path +set_data_path( + path_to_nc = data_path, + ask = FALSE, + write_config = FALSE, + copy_example = TRUE +) +################################################################################ + +test_that("location_slice", { + locations <- data.frame( + name = c("A", "B", "C", "D"), + longitude = c(0, 90, -120, -9), latitude = c(20, 45, 60, 37), + time_bp = c(0, -10000, -20000, -10000) + ) + + this_series <- region_series( + bio_variables = c("bio01", "bio12"), + dataset = "Example" + ) + + # using a data frame of locations and a separate vector of + this_climate <- location_slice_from_region_series( + x = locations[, c("longitude", "latitude")], + time_bp = locations$time_bp, region_series = this_series, nn_interpol = FALSE + ) + expect_false(is.na(this_climate[1, "bio01"])) + expect_true(is.na(this_climate[3, "bio01"])) + expect_true(is.na(this_climate[4, "bio01"])) + + # this function is more thoroughly tested in locations_slice, which is a + # wrapper around this function with added code to generate the region series +}) + +################################################################################ +# clean up for the next test +unlink(data_path, recursive = TRUE) diff --git a/tests/testthat/test_region_series.R b/tests/testthat/test_region_series.R index 192b3dda..db645734 100644 --- a/tests/testthat/test_region_series.R +++ b/tests/testthat/test_region_series.R @@ -1,30 +1,34 @@ # set up data path for this test -data_path <- file.path(tempdir(),"pastclim_data") +data_path <- file.path(tempdir(), "pastclim_data") unlink(data_path, recursive = TRUE) # it should not exist, but remove it just in case # set data path -set_data_path(path_to_nc = data_path, - ask = FALSE, - write_config = FALSE, - copy_example = TRUE) +set_data_path( + path_to_nc = data_path, + ask = FALSE, + write_config = FALSE, + copy_example = TRUE +) ################################################################################ test_that("region series", { # using standard dataset climate_region <- region_series( - c(-20000, -10000), c("bio01", "bio12"), - "Example" + time_bp = c(-20000, -10000), bio_variables = c("bio01", "bio12"), + dataset = "Example" ) expect_true(inherits(climate_region, "SpatRasterDataset")) expect_true(all(names(climate_region) == c("bio01", "bio12"))) expect_true(all(terra::nlyr(climate_region) == c(2, 2))) # do the same for a custom dataset - example_filename <- getOption("pastclim.dataset_list")$file_name[getOption("pastclim.dataset_list")$dataset=="Example"][1] + example_filename <- getOption("pastclim.dataset_list")$file_name[getOption("pastclim.dataset_list")$dataset == "Example"][1] path_to_example_nc <- system.file("/extdata/", example_filename, - package = "pastclim" + package = "pastclim" ) - climate_region <- region_series(c(-20000, -10000), c("BIO1", "BIO10"), - "custom", + climate_region <- region_series( + time_bp = c(-20000, -10000), + bio_variables = c("BIO1", "BIO10"), + dataset = "custom", path_to_nc = path_to_example_nc ) expect_true(inherits(climate_region, "SpatRasterDataset")) @@ -33,46 +37,63 @@ test_that("region series", { # if we try to use a variable that does not exist expect_error( - region_series(c(-20000, -10000), c("bio01", "bio19"), "Example"), + region_series( + time_bp = c(-20000, -10000), + bio_variables = c("bio01", "bio19"), + dataset = "Example" + ), "bio19 not available" ) expect_error( - region_series(c(-20000, -10000), c("BIO1", "bio19"), "custom", + region_series( + time_bp = c(-20000, -10000), + bio_variables = c("BIO1", "bio19"), + dataset = "custom", path_to_nc = path_to_example_nc ), "variable \\(bio19\\) not" ) # if we try to use a variable that we have not downloaded yet - expect_error(region_series(c(-20000, -10000), - c("bio01", "bio19"), - "Krapp2021"), - "^variable \\(bio01, bio19\\) not yet downloaded") + expect_error( + region_series( + time_bp = c(-20000, -10000), + bio_variables = c("bio01", "bio19"), + dataset = "Krapp2021" + ), + "^variable \\(bio01, bio19\\) not yet downloaded" + ) # if we try to use a file that does not exist - expect_error(region_series(c(-20000, -10000), c("BIO1", "BIO12"), "custom", + expect_error(region_series( + time_bp = c(-20000, -10000), + bio_variables = c("BIO1", "BIO12"), + dataset = "custom", path_to_nc = "./foo" ), "path_to_nc does not point to a file") # if we use time steps that do not exist expect_error( region_series( - c(-19000, -10000), c("bio01", "bio12"), - "Example" + time_bp = c(-19000, -10000), + bio_variables = c("bio01", "bio12"), + dataset = "Example" ), "time_bp should only include time steps available in the dataset" ) - + # get all values - climate_region <- region_series(bio_variables = c("bio01", "bio12"), + climate_region <- region_series( + bio_variables = c("bio01", "bio12"), dataset = "Example" ) expect_true(all(terra::nlyr(climate_region) == c(5, 5))) - + # get all values climate_region <- region_series( - time_bp = list(min=-13000,max=0), c("bio01", "bio12"), - "Example" + time_bp = list(min = -13000, max = 0), + bio_variables = c("bio01", "bio12"), + dataset = "Example" ) expect_true(all(terra::nlyr(climate_region) == c(3, 3))) }) @@ -81,65 +102,63 @@ test_that("ext on region series", { # this should work expect_error(region_series( time_bp = -20000, - c("bio01", "bio10", "bio12"), + bio_variables = c("bio01", "bio10", "bio12"), dataset = "Example", ext = terra::ext(region_extent$Europe) - ),NA) - + ), NA) + # this should raise an error expect_error(region_series( time_bp = -20000, - c("bio01", "bio10", "bio12"), + bio_variables = c("bio01", "bio10", "bio12"), dataset = "Example", ext = "foo" ), "ext should be a ") - + # not enough elements - ext<-c(-15, 70, 33) + ext <- c(-15, 70, 33) expect_error(region_series( time_bp = -20000, - c("bio01", "bio10", "bio12"), + bio_variables = c("bio01", "bio10", "bio12"), dataset = "Example", ext = ext ), "ext should be a ") - + # but this works as it is long enough - ext<-c(-15, 70, 33, 75) + ext <- c(-15, 70, 33, 75) expect_error(region_series( time_bp = -20000, - c("bio01", "bio10", "bio12"), + bio_variables = c("bio01", "bio10", "bio12"), dataset = "Example", ext = ext - ), NA) + ), NA) }) - test_that("crop on region series", { +test_that("crop on region series", { + # this should work + expect_error(region_series( + time_bp = -20000, + bio_variables = c("bio01", "bio10", "bio12"), + dataset = "Example", + crop = terra::vect(region_outline$Eurasia) + ), NA) - # this should work - expect_error(region_series( - time_bp = -20000, - c("bio01", "bio10", "bio12"), - dataset = "Example", - crop = terra::vect(region_outline$Eurasia) - ),NA) - - # this should raise an error - expect_error(region_series( - time_bp = -20000, - c("bio01", "bio10", "bio12"), - dataset = "Example", - crop = "foo" - ), "crop should be a ") - - # this should work - expect_error(region_series( - time_bp = -20000, - c("bio01", "bio10", "bio12"), - dataset = "Example", - crop = region_outline$Eurasia),NA) - + # this should raise an error + expect_error(region_series( + time_bp = -20000, + bio_variables = c("bio01", "bio10", "bio12"), + dataset = "Example", + crop = "foo" + ), "crop should be a ") + # this should work + expect_error(region_series( + time_bp = -20000, + bio_variables = c("bio01", "bio10", "bio12"), + dataset = "Example", + crop = region_outline$Eurasia + ), NA) }) ################################################################################ # clean up for the next test -unlink(data_path, recursive = TRUE) +unlink(data_path, recursive = TRUE) diff --git a/tests/testthat/test_region_slice.R b/tests/testthat/test_region_slice.R index 0c187069..2509af5d 100644 --- a/tests/testthat/test_region_slice.R +++ b/tests/testthat/test_region_slice.R @@ -1,30 +1,37 @@ # set up data path for this test -data_path <- file.path(tempdir(),"pastclim_data") +data_path <- file.path(tempdir(), "pastclim_data") unlink(data_path, recursive = TRUE) # it should not exist, but remove it just in case # set data path -set_data_path(path_to_nc = data_path, - ask = FALSE, - write_config = FALSE, - copy_example = TRUE) +set_data_path( + path_to_nc = data_path, + ask = FALSE, + write_config = FALSE, + copy_example = TRUE +) ################################################################################ test_that("region slice", { # using standard dataset climate_slice <- region_slice( - c(-10000), c("bio01", "bio12"), - "Example" + time_bp = c(-10000), + bio_variables = c("bio01", "bio12"), + dataset = "Example" ) expect_true(inherits(climate_slice, "SpatRaster")) expect_true(all(varnames(climate_slice) == c("bio01", "bio12"))) expect_true(terra::nlyr(climate_slice) == c(2)) # do the same for a custom dataset - example_filename <- getOption("pastclim.dataset_list")$file_name[getOption("pastclim.dataset_list")$dataset=="Example"][1] + example_filename <- getOption("pastclim.dataset_list")$file_name[ + getOption("pastclim.dataset_list")$dataset == "Example" + ][1] path_to_example_nc <- system.file("/extdata/", example_filename, - package = "pastclim" + package = "pastclim" ) - climate_slice <- region_slice(c(-10000), c("BIO1", "BIO10"), - "custom", + climate_slice <- region_slice( + time_bp = c(-10000), + bio_variables = c("BIO1", "BIO10"), + dataset = "custom", path_to_nc = path_to_example_nc ) expect_true(inherits(climate_slice, "SpatRaster")) @@ -33,8 +40,9 @@ test_that("region slice", { expect_error( region_slice( - c(-10000, -20000), c("bio01", "bio12"), - "Example" + time_bp = c(-10000, -20000), + bio_variables = c("bio01", "bio12"), + dataset = "Example" ), "time_bp should be a single time step" ) @@ -42,4 +50,4 @@ test_that("region slice", { ################################################################################ # clean up for the next test -unlink(data_path, recursive = TRUE) +unlink(data_path, recursive = TRUE) diff --git a/tests/testthat/test_remote_files.R b/tests/testthat/test_remote_files.R new file mode 100644 index 00000000..efb941a6 --- /dev/null +++ b/tests/testthat/test_remote_files.R @@ -0,0 +1,47 @@ +## This is a resource intensive test. It downloads all files in the dataset_list +## and then validates them. It is only run if the appropriate environment +## variable is set, and thus skipped most of the time +## To set the environment variable, use: +## Sys.setenv(PASTCLIM_TEST = "download_full") +## remember to unset it once you are done +## Sys.unsetenv("PASTCLIM_TEST") + + +# set up data path for this test +data_path <- file.path(tempdir(), "pastclim_data") +unlink(data_path, recursive = TRUE) # it should not exist, but remove it just in case +# set data path +set_data_path( + path_to_nc = data_path, + ask = FALSE, + write_config = FALSE, + copy_example = TRUE +) +################################################################################ +test_that("download and validate all files", { + skip_if(Sys.getenv("PASTCLIM_TEST") != "download_full") + # download all files for each dataset + all_datasets <- get_available_datasets() + all_datasets <- all_datasets[!all_datasets %in% "Example"] + for (i_dataset in all_datasets) { + expect_true(download_dataset(dataset = i_dataset)) + } + # now check that the files we downloaded are valid + for (i_file in list.files(get_data_path())) { + expect_true(validate_nc(i_file)) + } + # check that the variables in the table are found in the respective files + meta_table <- getOption("pastclim.dataset_list") + for (i_row in 1:nrow(meta_table)) { + nc_in <- ncdf4::nc_open(file.path(in_dir, meta_table$file_name[i])) + # check below if !! works to unquote the expression + expect_true(!!meta_table$ncvar[i] %in% names(nc_in$var)) + ncdf4::nc_close(nc_in) + } + # for each dataset, check that all variables cover the same extent and have + # the same missing values +}) + +################################################################################ +# clean up for the next test +unlink(data_path, recursive = TRUE) diff --git a/tests/testthat/test_sample_region_series.R b/tests/testthat/test_sample_region_series.R index 8523cd2f..48f9dc09 100644 --- a/tests/testthat/test_sample_region_series.R +++ b/tests/testthat/test_sample_region_series.R @@ -1,21 +1,23 @@ # set up data path for this test -data_path <- file.path(tempdir(),"pastclim_data") +data_path <- file.path(tempdir(), "pastclim_data") unlink(data_path, recursive = TRUE) # it should not exist, but remove it just in case # set data path -set_data_path(path_to_nc = data_path, - ask = FALSE, - write_config = FALSE, - copy_example = TRUE) +set_data_path( + path_to_nc = data_path, + ask = FALSE, + write_config = FALSE, + copy_example = TRUE +) ################################################################################ test_that("sample_region_series works correctly", { set.seed(123) # sample series - t_steps <- c(-20000,-10000) + t_steps <- c(-20000, -10000) vars <- c("bio01", "bio10", "bio12") climate_ts <- region_series( time_bp = t_steps, - vars, + bio_variables = vars, dataset = "Example", ext = terra::ext(region_extent$Europe) ) @@ -37,20 +39,24 @@ test_that("sample_region_series works correctly", { expect_error( sampled_var <- sample_region_series(climate_ts, size = n_points), "at least one element of sample size should be larger than zero" - ) + ) # now use a single sample size for all layers n_points <- 10 sampled_fixed <- sample_region_series(climate_ts, size = n_points) expect_true(nrow(sampled_fixed) == n_points * length(t_steps)) expect_true(sum(is.na(sampled_fixed)) == 0) - sampled_fixed <- sample_region_series(climate_ts, size = n_points, - na.rm = FALSE) + sampled_fixed <- sample_region_series(climate_ts, + size = n_points, + na.rm = FALSE + ) expect_true(sum(is.na(sampled_fixed)) > 0) climate_ts[1] <- climate_ts[1][[1]] - expect_error(sample_region_series(climate_ts, size = n_points), - "x is not a valid object generated by region_series") + expect_error( + sample_region_series(climate_ts, size = n_points), + "x is not a valid object generated by region_series" + ) }) ################################################################################ # clean up for the next test -unlink(data_path, recursive = TRUE) +unlink(data_path, recursive = TRUE) diff --git a/tests/testthat/test_sample_region_slice.R b/tests/testthat/test_sample_region_slice.R index c668e06a..093f7c0d 100644 --- a/tests/testthat/test_sample_region_slice.R +++ b/tests/testthat/test_sample_region_slice.R @@ -1,11 +1,13 @@ # set up data path for this test -data_path <- file.path(tempdir(),"pastclim_data") +data_path <- file.path(tempdir(), "pastclim_data") unlink(data_path, recursive = TRUE) # it should not exist, but remove it just in case # set data path -set_data_path(path_to_nc = data_path, - ask = FALSE, - write_config = FALSE, - copy_example = TRUE) +set_data_path( + path_to_nc = data_path, + ask = FALSE, + write_config = FALSE, + copy_example = TRUE +) ################################################################################ test_that("sample_region_slice samples correctly", { @@ -15,16 +17,18 @@ test_that("sample_region_slice samples correctly", { dataset = "Example" ) set.seed(123) - this_sample<-sample_region_slice(climate_20k,10) - expect_true(nrow(this_sample)==10) - expect_true(sum(is.na(this_sample))==0) - this_sample<-sample_region_slice(climate_20k,10, na.rm=FALSE) - expect_true(sum(is.na(this_sample))>0) + this_sample <- sample_region_slice(climate_20k, 10) + expect_true(nrow(this_sample) == 10) + expect_true(sum(is.na(this_sample)) == 0) + this_sample <- sample_region_slice(climate_20k, 10, na.rm = FALSE) + expect_true(sum(is.na(this_sample)) > 0) # error if we give more than one size (as we do for sample_region_series) - expect_error(sample_region_slice(climate_20k,c(10,10)), - "size should be a single value") + expect_error( + sample_region_slice(climate_20k, c(10, 10)), + "size should be a single value" + ) }) ################################################################################ # clean up for the next test -unlink(data_path, recursive = TRUE) +unlink(data_path, recursive = TRUE) diff --git a/tests/testthat/test_slice_region_series.R b/tests/testthat/test_slice_region_series.R index 3e7ea1b2..59188efd 100644 --- a/tests/testthat/test_slice_region_series.R +++ b/tests/testthat/test_slice_region_series.R @@ -1,23 +1,30 @@ # set up data path for this test -data_path <- file.path(tempdir(),"pastclim_data") +data_path <- file.path(tempdir(), "pastclim_data") unlink(data_path, recursive = TRUE) # it should not exist, but remove it just in case # set data path -set_data_path(path_to_nc = data_path, - ask = FALSE, - write_config = FALSE, - copy_example = TRUE) +set_data_path( + path_to_nc = data_path, + ask = FALSE, + write_config = FALSE, + copy_example = TRUE +) ################################################################################ test_that("climate_for_time_slice", { climate_region <- region_series( - c(-20000, -10000), c("bio01", "bio12"), - "Example" + time_bp = c(-20000, -10000), + bio_variables = c("bio01", "bio12"), + dataset = "Example" ) my_slice <- slice_region_series(climate_region, time_bp = -10000) expect_true(inherits(my_slice, "SpatRaster")) expect_true(length(my_slice) == 1) expect_true(terra::nlyr(my_slice) == 2) expect_true(all(varnames(my_slice) == c("bio01", "bio12"))) + # now do the same with time_ce + my_slice_ce <- slice_region_series(climate_region, time_ce = -8050) + expect_identical(time(my_slice), time(my_slice_ce)) + # use a time step that does not exist expect_error( slice_region_series(climate_region, time_bp = -19000), @@ -30,10 +37,12 @@ test_that("climate_for_time_slice", { ) # pass an object that is not valid climate_region[1] <- climate_region[1][[1]] - expect_error(slice_region_series(climate_region, time_bp = -10000), - "x is not a valid object generated by region_series") + expect_error( + slice_region_series(climate_region, time_bp = -10000), + "x is not a valid object generated by region_series" + ) }) ################################################################################ # clean up for the next test -unlink(data_path, recursive = TRUE) +unlink(data_path, recursive = TRUE) diff --git a/tests/testthat/test_time_bp.R b/tests/testthat/test_time_bp.R index 3272e77b..f3bc4ce4 100644 --- a/tests/testthat/test_time_bp.R +++ b/tests/testthat/test_time_bp.R @@ -1,33 +1,46 @@ # set up data path for this test -data_path <- file.path(tempdir(),"pastclim_data") +data_path <- file.path(tempdir(), "pastclim_data") unlink(data_path, recursive = TRUE) # it should not exist, but remove it just in case # set data path -set_data_path(path_to_nc = data_path, - ask = FALSE, - write_config = FALSE, - copy_example = TRUE) +set_data_path( + path_to_nc = data_path, + ask = FALSE, + write_config = FALSE, + copy_example = TRUE +) ################################################################################ -test_that("time_bp", { +test_that("time_bp for SpatRaster", { # using standard dataset climate_slice <- region_slice( - c(-10000), c("bio01", "bio12"), - "Example" + time_bp = c(-10000), + bio_variables = c("bio01", "bio12"), + dataset = "Example" ) - expect_true(all(time_bp(climate_slice)==c(-10000,-10000))) + expect_true(all(time_bp(climate_slice) == c(-10000, -10000))) # the method will only work on a SpatRaster - expect_error(time_bp("blah"),"unable to find an inherited method") - + expect_error(time_bp("blah"), "unable to find an inherited method") + # set the time units incorrectly to raw - time(climate_slice)<-c(-20,-100) - expect_error(time_bp(climate_slice),"^The time units of SpatRaster are not") - + time(climate_slice) <- c(-20, -100) + expect_error(time_bp(climate_slice), "^The time units of SpatRaster are not") + # and now let's fix them back - time_bp(climate_slice) <- c(-10000,-10000) - expect_true(all(time_bp(climate_slice)==c(-10000,-10000))) - + time_bp(climate_slice) <- c(-10000, -10000) + expect_true(all(time_bp(climate_slice) == c(-10000, -10000))) +}) + +test_that("time_bp for SpatRasterDataset", { + # using standard dataset + climate_series <- region_series( + bio_variables = c("bio01", "bio12"), + dataset = "Example" + ) + expect_true(all(time_bp(climate_series) == c(-20000, -15000, -10000, -5000, 0))) + time_bp(climate_series) <- c(-20, -15, -10, -5, 0) + expect_true(all(time(climate_series[1]) == c(1930, 1935, 1940, 1945, 1950))) }) ################################################################################ # clean up for the next test -unlink(data_path, recursive = TRUE) +unlink(data_path, recursive = TRUE) diff --git a/tests/testthat/test_time_bp_series.R b/tests/testthat/test_time_bp_series.R index 045dad4b..a3270446 100644 --- a/tests/testthat/test_time_bp_series.R +++ b/tests/testthat/test_time_bp_series.R @@ -1,45 +1,52 @@ # set up data path for this test -data_path <- file.path(tempdir(),"pastclim_data") +data_path <- file.path(tempdir(), "pastclim_data") unlink(data_path, recursive = TRUE) # it should not exist, but remove it just in case # set data path -set_data_path(path_to_nc = data_path, - ask = FALSE, - write_config = FALSE, - copy_example = TRUE) +set_data_path( + path_to_nc = data_path, + ask = FALSE, + write_config = FALSE, + copy_example = TRUE +) ################################################################################ test_that("time_bp_to_i_series returns correct values", { - time_bp <- c(-10000,-20000) - time_steps <- sort(-seq(0,20000,by = 5000)) + time_bp <- c(-10000, -20000) + time_steps <- sort(-seq(0, 20000, by = 5000)) ##################################################### # if time_bp is a vector ##################################################### - # correctly working - expect_true(all(time_bp_to_i_series(time_bp,time_steps)==c(3,1))) + # correctly working + expect_true(all(time_bp_to_i_series(time_bp, time_steps) == c(3, 1))) # incorrect values - time_bp <- c(-9000,-20000) - expect_error(time_bp_to_i_series(time_bp,time_steps), - "time_bp should only include time steps available in the dataset") + time_bp <- c(-9000, -20000) + expect_error( + time_bp_to_i_series(time_bp, time_steps), + "time_bp should only include time steps available in the dataset" + ) ##################################################### # if time_bp is a list ##################################################### - time_bp <- list(min=-15000, max=-3000) - expect_true(all(time_bp_to_i_series(time_bp,time_steps)==c(2,3,4))) - time_bp <- list(min=-3000, max=-15000) - expect_error(time_bp_to_i_series(time_bp,time_steps), - "in time_bp, min should be less than max") + time_bp <- list(min = -15000, max = -3000) + expect_true(all(time_bp_to_i_series(time_bp, time_steps) == c(2, 3, 4))) + time_bp <- list(min = -3000, max = -15000) + expect_error( + time_bp_to_i_series(time_bp, time_steps), + "in time_bp, min should be less than max" + ) ##################################################### # if time_bp is null ##################################################### - expect_true(is.null(time_bp_to_i_series(NULL,time_steps))) + expect_true(is.null(time_bp_to_i_series(NULL, time_steps))) ##################################################### # if time_bp is nonsense ##################################################### - expect_error(time_bp_to_i_series("blah",time_steps), - "time_bp can only be") + expect_error( + time_bp_to_i_series("blah", time_steps), + "time_bp can only be" + ) }) ################################################################################ # clean up for the next test -unlink(data_path, recursive = TRUE) - +unlink(data_path, recursive = TRUE) diff --git a/tests/testthat/test_validate_nc.R b/tests/testthat/test_validate_nc.R index 0f7f4647..242fdec1 100644 --- a/tests/testthat/test_validate_nc.R +++ b/tests/testthat/test_validate_nc.R @@ -1,69 +1,91 @@ # set up data path for this test -data_path <- file.path(tempdir(),"pastclim_data") +data_path <- file.path(tempdir(), "pastclim_data") unlink(data_path, recursive = TRUE) # it should not exist, but remove it just in case # set data path -set_data_path(path_to_nc = data_path, - ask = FALSE, - write_config = FALSE, - copy_example = TRUE) -example_nc_filename <- unique(getOption("pastclim.dataset_list")$file_name[ - getOption("pastclim.dataset_list")$dataset == "Example"]) -path_to_example_nc <- file.path(get_data_path(),example_nc_filename) -path_to_broken_nc <- file.path(get_data_path(),"broken.nc") +set_data_path( + path_to_nc = data_path, + ask = FALSE, + write_config = FALSE, + copy_example = TRUE +) +example_nc_filename <- unique(getOption("pastclim.dataset_list")$file_name[ + getOption("pastclim.dataset_list")$dataset == "Example" +]) +path_to_example_nc <- file.path(get_data_path(), example_nc_filename) +path_to_broken_nc <- file.path(get_data_path(), "broken.nc") ################################################################################ test_that("validate_nc for custom file", { # error for non-existing file - expect_error(validate_nc("blah/blah"), - "The provided path_to_nc") + expect_error( + validate_nc("blah/blah"), + "The provided path_to_nc" + ) # copy example file and start changing it for tests - file.copy(path_to_example_nc, - path_to_broken_nc) + file.copy( + path_to_example_nc, + path_to_broken_nc + ) # validate before breaking expect_true(validate_nc(path_to_nc = path_to_broken_nc)) # remove long name nc_in <- ncdf4::nc_open(path_to_broken_nc, write = TRUE) - ncdf4::ncatt_put(nc = nc_in, - varid = "BIO1", - attname = "long_name", - attval="", - definemode = TRUE) + ncdf4::ncatt_put( + nc = nc_in, + varid = "BIO1", + attname = "long_name", + attval = "", + definemode = TRUE + ) ncdf4::nc_close(nc_in) - expect_error(validate_nc(path_to_nc = path_to_broken_nc), - "for BIO1 the longname is not given") + expect_error( + validate_nc(path_to_nc = path_to_broken_nc), + "for BIO1 the longname is not given" + ) # get a new version to edit the time units file.copy(path_to_example_nc, - path_to_broken_nc, overwrite = TRUE) + path_to_broken_nc, + overwrite = TRUE + ) nc_in <- ncdf4::nc_open(path_to_broken_nc, write = TRUE) - ncdf4::ncatt_put(nc = nc_in, - varid = "time", - attname = "units", - attval="days since 1970", - definemode = TRUE) + ncdf4::ncatt_put( + nc = nc_in, + varid = "time", + attname = "units", + attval = "days since 1970", + definemode = TRUE + ) ncdf4::nc_close(nc_in) - expect_error(validate_nc(path_to_nc = path_to_broken_nc), - "the time units should start with") + expect_error( + validate_nc(path_to_nc = path_to_broken_nc), + "the time units should start with" + ) nc_in <- ncdf4::nc_open(path_to_broken_nc, write = TRUE) - ncdf4::ncatt_put(nc = nc_in, - varid = "time", - attname = "units", - attval="years since present", - definemode = TRUE) + ncdf4::ncatt_put( + nc = nc_in, + varid = "time", + attname = "units", + attval = "years since present", + definemode = TRUE + ) ncdf4::nc_close(nc_in) - expect_error(validate_nc(path_to_nc = path_to_broken_nc), - "the time units are ") + expect_error( + validate_nc(path_to_nc = path_to_broken_nc), + "the time units are " + ) # and now fix it nc_in <- ncdf4::nc_open(path_to_broken_nc, write = TRUE) - ncdf4::ncatt_put(nc = nc_in, - varid = "time", - attname = "units", - attval="years since 1970", - definemode = TRUE) - ncdf4::nc_close(nc_in) + ncdf4::ncatt_put( + nc = nc_in, + varid = "time", + attname = "units", + attval = "years since 1970", + definemode = TRUE + ) + ncdf4::nc_close(nc_in) expect_true(validate_nc(path_to_nc = path_to_broken_nc)) - }) ################################################################################ # clean up for the next test -unlink(data_path, recursive = TRUE) +unlink(data_path, recursive = TRUE) diff --git a/tests/testthat/test_var_labels.R b/tests/testthat/test_var_labels.R index c7311882..bdbe8b6f 100644 --- a/tests/testthat/test_var_labels.R +++ b/tests/testthat/test_var_labels.R @@ -1,35 +1,47 @@ # set up data path for this test -data_path <- file.path(tempdir(),"pastclim_data") +data_path <- file.path(tempdir(), "pastclim_data") unlink(data_path, recursive = TRUE) # it should not exist, but remove it just in case # set data path -set_data_path(path_to_nc = data_path, - ask = FALSE, - write_config = FALSE, - copy_example = TRUE) +set_data_path( + path_to_nc = data_path, + ask = FALSE, + write_config = FALSE, + copy_example = TRUE +) ################################################################################ test_that("var_labels for plots", { - # check that we can correctly return expressions for every variable (i.e. + # check that we can correctly return expressions for every variable (i.e. # that nothing is malforms and crashes the parsing) - for (i in get_available_datasets()){ + for (i in list_available_datasets()) { my_labels <- var_labels(get_vars_for_dataset(i), dataset = i) - expect_true(inherits(my_labels,"expression")) - my_labels <- var_labels(get_vars_for_dataset(i), dataset = i, - with_units = FALSE) - expect_true(inherits(my_labels,"expression")) - my_labels <- var_labels(get_vars_for_dataset(i), dataset = i, - abbreviated = TRUE) - expect_true(inherits(my_labels,"expression")) - my_labels <- var_labels(get_vars_for_dataset(i), dataset = i, - with_units = FALSE, abbreviated = TRUE) - expect_true(inherits(my_labels,"expression")) + expect_true(inherits(my_labels, "expression")) + my_labels <- var_labels(get_vars_for_dataset(i), + dataset = i, + with_units = FALSE + ) + expect_true(inherits(my_labels, "expression")) + my_labels <- var_labels(get_vars_for_dataset(i), + dataset = i, + abbreviated = TRUE + ) + expect_true(inherits(my_labels, "expression")) + my_labels <- var_labels(get_vars_for_dataset(i), + dataset = i, + with_units = FALSE, abbreviated = TRUE + ) + expect_true(inherits(my_labels, "expression")) } # error for non-existent variable - expect_error(var_labels( "blah", dataset = "Example"), - "blah does not exist in dataset Example") + expect_error( + var_labels("blah", dataset = "Example"), + "blah does not exist in dataset Example" + ) # error for non-existent dataset - expect_error(var_labels( "blah", dataset = "blah"), - "^dataset should be one of") + expect_error( + var_labels("blah", dataset = "blah"), + "^dataset should be one of" + ) # labels for SpatRaster climate_20k <- region_slice( time_bp = -20000, @@ -37,13 +49,14 @@ test_that("var_labels for plots", { dataset = "Example" ) my_labels <- var_labels(climate_20k, dataset = "Example") - expect_true(inherits(my_labels,"expression")) + expect_true(inherits(my_labels, "expression")) # error if x is not a correct object - expect_error(var_labels(matrix(1:4,ncol=1), dataset = "Example"), - "x should be either a character vector or a SpatRaster") -} -) + expect_error( + var_labels(matrix(1:4, ncol = 1), dataset = "Example"), + "x should be either a character vector or a SpatRaster" + ) +}) ################################################################################ # clean up for the next test -unlink(data_path, recursive = TRUE) +unlink(data_path, recursive = TRUE) diff --git a/tests/testthat/test_ybp2date.R b/tests/testthat/test_ybp2date.R new file mode 100644 index 00000000..76c6a6fd --- /dev/null +++ b/tests/testthat/test_ybp2date.R @@ -0,0 +1,8 @@ +test_that("ybp2date converts correctly", { + # the reference year is 1950 + expect_true(lubridate::year(ybp2date(0)) == 1950) + expect_true(lubridate::year(ybp2date(-10000)) == -8050) + # check correct back and forth + converted_date <- ybp2date(-10000) + expect_true(date2ybp(converted_date) == -10000) +}) diff --git a/vignettes/a0_pastclim_overview.Rmd b/vignettes/a0_pastclim_overview.Rmd index 6bb3bc60..1e7453f9 100644 --- a/vignettes/a0_pastclim_overview.Rmd +++ b/vignettes/a0_pastclim_overview.Rmd @@ -34,24 +34,25 @@ done so already, install it from CRAN with need to upgrade to both: ```{r install_dev, eval=FALSE} -install.packages('terra', repos='https://rspatial.r-universe.dev') -devtools::install_github("EvolEcolGroup/pastclim", ref="dev") +install.packages("terra", repos = "https://rspatial.r-universe.dev") +devtools::install_github("EvolEcolGroup/pastclim", ref = "dev") ``` -On its dedicated [website](https://evolecolgroup.github.io/pastclim/), you can find -Articles giving you a step-by-step [overview of the package](https://evolecolgroup.github.io/pastclim/articles/a0_pastclim_overview.html), -and a [cheatsheet](https://evolecolgroup.github.io/pastclim/pastclim_cheatsheet.pdf). -There is also a -[version](https://evolecolgroup.github.io/pastclim/dev/) of the site -updated for the `dev` version (on the top left, the version number is in -red, and will be in the format x.x.x.9xxx, indicating it is a -development version). +On its dedicated [website](https://evolecolgroup.github.io/pastclim/), +you can find Articles giving you a step-by-step [overview of the +package](https://evolecolgroup.github.io/pastclim/articles/a0_pastclim_overview.html), +and a +[cheatsheet](https://evolecolgroup.github.io/pastclim/pastclim_cheatsheet.pdf). +There is also a [version](https://evolecolgroup.github.io/pastclim/dev/) +of the site updated for the `dev` version (on the top left, the version +number is in red, and will be in the format x.x.x.9xxx, indicating it is +a development version). If you want to build the vignette directly in `R` when installing `pastclim` from GitHub, you can : ```{r install_vignette, eval=FALSE} -devtools::install_github("EvolEcolGroup/pastclim", ref="dev", build_vignettes = TRUE) +devtools::install_github("EvolEcolGroup/pastclim", ref = "dev", build_vignettes = TRUE) ``` And read it directly in R with: @@ -63,40 +64,26 @@ vignette("pastclim_overview", package = "pastclim") Depending on the operating system you use, you might need additional packages to build a vignette. ------------------------------------------------------------------------- - -NOTE: `pastclim` relies on `terra` to process rasters. There is a known -bug in `terra` that leads to the occasional message: - -``` -"Error in x$.self$finalize() : attempt to apply non-function" -``` - -being reported. This is an error related to garbage collection, which -does not affect the script being correctly executed, so it can be -ignored. More discussion of this issue can be found on -[stack**overflow**](https://stackoverflow.com/questions/61598340/why-does-rastertopoints-generate-an-error-on-first-call-but-not-second) - # Download the data You will need to download climatic reconstructions before being able to -do any real work with `pastclim`. Currently the library contains two -datasets: *Beyer2020* which covers the last 120k years; and, for project -that go further back in time, *Krapp2021* which goes back to 800kya. It -is possible to add additional, custom datasets, but you will need some -familiarity with handling `netcdf` files (see the vignette on 'custom -dataset'). - -```{r eval=FALSE} -vignette("custom_datasets", package = "pastclim") -``` +do any real work with `pastclim`. +Pastclim currently includes data from Beyer et al 2020 (*Beyer2020*, a reconstruction +of climate based on the HadCM3 model for the last 120k years), Krapp +et al 2021 (*Krapp2021*, which covers the last 800k years with a statistical emulator of HadCM3), +Barreto et al 2023 (*Barreto2023*), covering the last 5M years using the PALEO-PGEM emulator), +and the WorldClim data ("WorldClim_2.1_*", present, and future projections with a number of models and +emission scenarios). More information on each of these +datasets can be found +[here](https://evolecolgroup.github.io/pastclim/articles/a1_available_datasets.html). +For detailed instructions on how to use the WorldClim dataset, can be found in [this article](https://evolecolgroup.github.io/pastclim/articles/a3_pastclim_present_and_future.html) +There are also instructions on how to build and use [custom +datasets](https://evolecolgroup.github.io/pastclim/articles/a2_custom_datasets.html), +but you will need some +familiarity with handling `netcdf` files. A list of all datasets available can be obtained by typing -```{r eval=FALSE} -vignette("available_datasets", package = "pastclim") -``` - Please be aware that using any dataset made available to `pastclim` will require to cite both `pastclim` as well as the original publication presenting the dataset. The reference to cite for `pastclim` can be @@ -115,7 +102,7 @@ help("Beyer2020") ``` ```{r echo=FALSE} -pastclim:::get_dataset_info(dataset="Beyer2020") +pastclim:::get_dataset_info(dataset = "Beyer2020") ``` For the datasets available in `pastclim`, there are functions that help @@ -131,7 +118,7 @@ set_data_path() ```{r echo=FALSE, results='hide'} library(pastclim) -set_data_path_for_CRAN() +set_data_path(on_CRAN = TRUE) ``` ``` @@ -171,7 +158,7 @@ get_vars_for_dataset(dataset = "Example") and the available time steps can be obtained with: ```{r} -get_time_steps(dataset = "Example") +get_time_bp_steps(dataset = "Example") ``` For *Beyer2020* and *Krapp2021*, you can get a list of available @@ -187,13 +174,20 @@ and get_vars_for_dataset(dataset = "Krapp2021") ``` +Note that, by default, only annual variables are shown. To see the available +monthly variables, simply use: +```{r} +get_vars_for_dataset(dataset = "Beyer2020", annual = FALSE, monthly = TRUE) +``` + + For monthly variables, months are coded as "\_xx" at the end of the variable names; e.g. "temperature_02" is the mean monthly temperature for February. A more thorough description of each variable (including the units) can be obtained with: ```{r} -get_vars_for_dataset(dataset="Example", details = TRUE) +get_vars_for_dataset(dataset = "Example", details = TRUE) ``` You will not be able to get the available time steps until you download @@ -242,9 +236,9 @@ climatic reconstructions. ```{r} locations <- data.frame( - name = c("Iho Eleru","La Riera", "Chalki", "Oronsay","Atlantis"), - longitude = c(5,-4, 27, -6, -24), latitude = c(7, 44, 36, 56, 31), - time_bp = c(-11200, -18738,-10227, -10200, -11600) + name = c("Iho Eleru", "La Riera", "Chalki", "Oronsay", "Atlantis"), + longitude = c(5, -4, 27, -6, -24), latitude = c(7, 44, 36, 56, 31), + time_bp = c(-11200, -18738, -10227, -10200, -11600) ) locations ``` @@ -274,7 +268,8 @@ neighbouring pixels if the location is just off one or more land pixels: ```{r} location_slice( x = locations, bio_variables = c("bio01", "bio12"), - dataset = "Example", nn_interpol = TRUE) + dataset = "Example", nn_interpol = TRUE +) ``` For Chalki, we can see that the problem is indeed that, since it is a @@ -293,7 +288,8 @@ thus allowing us to see how climate changed over time: locations_ts <- location_series( x = locations, bio_variables = c("bio01", "bio12"), - dataset = "Example") + dataset = "Example" +) ``` The resulting dataframe can be subsetted to get the time series for each @@ -315,9 +311,9 @@ We can quickly plot `bio01` through time for the locations: ```{r, warning=TRUE, fig.width=4, fig.height=3} library(ggplot2) -ggplot(data=locations_ts, aes(x=time_bp, y=bio01, group=name)) + - geom_line(aes(col=name))+ - geom_point(aes(col=name)) +ggplot(data = locations_ts, aes(x = time_bp, y = bio01, group = name)) + + geom_line(aes(col = name)) + + geom_point(aes(col = name)) ``` As expected, we don't have data for Atlantis (as it is always @@ -334,11 +330,13 @@ Pretty labels for environmental variables can be generated with ```{r, warning=TRUE, fig.width=4, fig.height=3} library(ggplot2) -ggplot(data=locations_ts, aes(x=time_bp, y=bio01, group=name)) + - geom_line(aes(col=name))+ - geom_point(aes(col=name))+ - labs(y = var_labels("bio01", dataset="Example", abbreviated=TRUE), - x = "time BP (yr)") +ggplot(data = locations_ts, aes(x = time_bp, y = bio01, group = name)) + + geom_line(aes(col = name)) + + geom_point(aes(col = name)) + + labs( + y = var_labels("bio01", dataset = "Example", abbreviated = TRUE), + x = "time BP (yr)" + ) ``` *Note* that these climatic reconstructions were extracted from the @@ -390,8 +388,9 @@ terra::plot(climate_20k) We can add more informative labels with `var_labels`: ```{r, fig.width=6, fig.height=5} -terra::plot(climate_20k, - main = var_labels(climate_20k, dataset = "Example", abbreviated = TRUE)) +terra::plot(climate_20k, + main = var_labels(climate_20k, dataset = "Example", abbreviated = TRUE) +) ``` It is possible to also load a time series of rasters with the function @@ -400,9 +399,10 @@ It is possible to also load a time series of rasters with the function ```{r} climate_region <- region_series( - time_bp = list(min = -15000, max = 0), + time_bp = list(min = -15000, max = 0), bio_variables = c("bio01", "bio10", "bio12"), - dataset = "Example") + dataset = "Example" +) climate_region ``` @@ -416,14 +416,14 @@ Note that `terra` stores dates in years as AD, not BP. You can inspect the times in years BP with: ```{r} -time_bp(climate_region$bio01) +time_bp(climate_region) ``` We can then plot the time series of a given variable (we relabel the plots to use years bp): ```{r, fig.width=6, fig.height=5} -terra::plot(climate_region$bio01, main=time_bp(climate_region$bio01)) +terra::plot(climate_region$bio01, main = time_bp(climate_region)) ``` To plot all climate variables for a given time step, we can slice the @@ -448,7 +448,7 @@ Which we can then use: ```{r} climate_mis1 <- region_series( - time_bp = mis1_steps, + time_bp = mis1_steps, bio_variables = c("bio01", "bio10", "bio12"), dataset = "Example" ) @@ -499,7 +499,7 @@ the area within the desired outline. ```{r, fig.width=6, fig.height=5} europe_climate_20k <- region_slice( time_bp = -20000, - c("bio01", "bio10", "bio12"), + bio_variables = c("bio01", "bio10", "bio12"), dataset = "Example", crop = region_outline$Europe ) @@ -514,9 +514,10 @@ library(sf) afr_eurasia <- sf::st_union(region_outline$Africa, region_outline$Eurasia) climate_20k_afr_eurasia <- region_slice( time_bp = -20000, - bio_variables = c("bio01", "bio10", "bio12"), + bio_variables = c("bio01", "bio10", "bio12"), dataset = "Example", - crop = afr_eurasia) + crop = afr_eurasia +) terra::plot(climate_20k_afr_eurasia) ``` @@ -539,7 +540,8 @@ climate_20k_custom <- region_slice( time_bp = -20000, bio_variables = c("bio01", "bio10", "bio12"), dataset = "Example", - crop = custom_vec) + crop = custom_vec +) terra::plot(climate_20k_custom) ``` @@ -573,7 +575,7 @@ terra::plot(biome_20k) The climate reconstructions do not show areas under permanent ice. Ice sheets are stored as class 28 in the "biome" variable. We can retrieve -directly the ice and land masks with: +directly the ice and land (all other biome categories) masks with: ```{r, fig.width=6, fig.height=2.5} ice_mask <- get_ice_mask(-20000, dataset = "Example") @@ -581,50 +583,99 @@ land_mask <- get_land_mask(-20000, dataset = "Example") terra::plot(c(ice_mask, land_mask)) ``` -We can also add the ice sheets to plots of climatic variables. First, we need to turn the -ice mask into polygons: +We can also add the ice sheets to plots of climatic variables. First, we +need to turn the ice mask into polygons: + ```{r} ice_mask_vect <- as.polygons(ice_mask) ``` -We can then add the polygons to each layer (i.e. variable) of climate slice with the following code (note that, to add the -polygons to every panel of the figure, we need to create a function that is used as -an argument for `fun` within `plot`): +We can then add the polygons to each layer (i.e. variable) of climate +slice with the following code (note that, to add the polygons to every +panel of the figure, we need to create a function that is used as an +argument for `fun` within `plot`): ```{r, fig.width=6, fig.height=5} -plot(climate_20k, - fun=function() polys(ice_mask_vect, col="gray", lwd=0.5)) +plot(climate_20k, + fun = function() polys(ice_mask_vect, col = "gray", lwd = 0.5) +) +``` + +In some other cases, we have multiple time points of the same variable +and we want to see how the ice sheets change: + +```{r, fig.width=6, fig.height=5} +europe_climate <- region_series( + time_bp = c(-20000, -15000, -10000, 0), + bio_variables = c("bio01"), + dataset = "Example", + ext = region_extent$Europe +) +ice_masks <- get_ice_mask(c(-20000, -15000, -10000, 0), + dataset = "Example" +) +ice_poly_list <- lapply(ice_masks, as.polygons) +plot(europe_climate$bio01, + main = time_bp(europe_climate), + fun = function(i) { + polys(ice_poly_list[[i]], + col = "gray", + lwd = 0.5 + ) + } +) +``` + +Note that to add the ice sheets in this instance, we build a function +that takes a single parameter *i* which is the index of the image (i.e. +*i* from 1 to 4 in the plot above) and use it to subset the list of ice +outlines. + +Sometimes it is interesting to measure the distance from the coastline +(e.g. when modelling species that rely on brackish water, or to +determine the distance from marine resources in archaeology). In +`pastclim`, we can use use `distance_from_sea`, which accounts for sea +level change based on the landmask: + +```{r, fig.width=6, fig.height=2.5} +distances_sea <- distance_from_sea(time_bp = c(-20000, 0), dataset = "Example") +distances_sea_australia <- crop(distances_sea, terra::ext(100, 170, -60, 20)) +plot(distances_sea_australia, main = time_bp(distances_sea_australia)) ``` # Adding locations to region plots -To plot locations on region plots, we first need to create a `SpatVector` object from -the dataframe of metadata, specifying the names of the columns with the x and y coordinates: +To plot locations on region plots, we first need to create a +`SpatVector` object from the dataframe of metadata, specifying the names +of the columns with the x and y coordinates: ```{r} -locations_vect <- vect(locations, geom=c("longitude", "latitude")) +locations_vect <- vect(locations, geom = c("longitude", "latitude")) locations_vect ``` -We can then add it to a climate slice with the following code (note that, to add the -points to every panel of the figure, we need to create a function that is used as -an argument for `fun` within `plot`): +We can then add it to a climate slice with the following code (note +that, to add the points to every panel of the figure, we need to create +a function that is used as an argument for `fun` within `plot`): + ```{r, fig.width=6, fig.height=5} -plot(europe_climate_20k, - fun=function() points(locations_vect, col="red", cex=2)) +plot(europe_climate_20k, + fun = function() points(locations_vect, col = "red", cex = 2) +) ``` -Only the points within the extent of the region will be plotted (so, in this case, only the European locations). +Only the points within the extent of the region will be plotted (so, in +this case, only the European locations). We can combine ice sheets and locations in a single plot: ```{r, fig.width=6, fig.height=5} -plot(europe_climate_20k, - fun=function() { - polys(ice_mask_vect, col="gray", lwd=0.5) - points(locations_vect, col="red", cex=2) - }) - +plot(europe_climate_20k, + fun = function() { + polys(ice_mask_vect, col = "gray", lwd = 0.5) + points(locations_vect, col = "red", cex = 2) + } +) ``` # Set the samples within the background @@ -640,8 +691,9 @@ climate_10k <- region_slice(-10000, dataset = "Example" ) climate_values_10k <- df_from_region_slice(climate_10k) -climate_10k_pca <- prcomp(climate_values_10k[, bio_vars], - scale = TRUE, center = TRUE) +climate_10k_pca <- prcomp(climate_values_10k[, bio_vars], + scale = TRUE, center = TRUE +) plot(climate_10k_pca$x[, 2] ~ climate_10k_pca$x[, 1], pch = 20, col = "lightgray", xlab = "PC1", ylab = "PC2" @@ -662,8 +714,9 @@ climate_loc_10k <- location_slice( time_bp = locations_10k$time_bp, bio_variables = bio_vars, dataset = "Example" ) -locations_10k_pca_scores <- predict(climate_10k_pca, - newdata = climate_loc_10k[, bio_vars]) +locations_10k_pca_scores <- predict(climate_10k_pca, + newdata = climate_loc_10k[, bio_vars] +) ``` And now we can plot the points on top of the background @@ -682,9 +735,9 @@ data frame with `df_from_region_series`. # Random sampling of background -For a number of species distribution models, rather than using the -complete background, we need to subsample background points to our -presences. If we are interested in a single time step, we can simply +In some instances (e.g. when the underlying raster is too large to handle), +it might be desirable to sample the background instead of using all values. If +we are interested in a single time step, we can simply generate the raster for the time slice of interest, and use `sample_region_slice`: @@ -698,22 +751,25 @@ this_sample <- sample_region_slice(climate_20k, size = 100) head(this_sample) ``` -We can also sample the background for multiple time steps (e.g. if we -want to match the background to the number of samples based on their -radiocarbon dates). So, for example, if we wanted 3 samples from 20k -years ago and 5 samples from 10k years ago: + +If we have samples from multiple time steps, we need to sample the background +proportionally to the number of points in each time step. So, for example, +if we wanted 30 samples from 20k +years ago and 50 samples from 10k years ago: ```{r} climate_ts <- region_series( - time_bp = c(-20000,-10000), + time_bp = c(-20000, -10000), bio_variables = c("bio01", "bio10", "bio12"), dataset = "Example", ext = terra::ext(region_extent$Europe) ) -sampled_climate <- sample_region_series(climate_ts, size = c(3,5)) +sampled_climate <- sample_region_series(climate_ts, size = c(3, 5)) sampled_climate ``` +We could then use these data to build a PCA. + # Downscaling `pastclim` does not contain built-in code to change the spatial @@ -725,8 +781,11 @@ At first we will need to extract a region and time of choice, in this case Europe 10,000 years ago ```{r, fig.width=6, fig.height=4} -europe_10k <- region_slice(dataset="Example", c("bio01"), - time_bp=-10000, ext=region_extent$Europe) +europe_10k <- region_slice( + dataset = "Example", + bio_variables = c("bio01"), + time_bp = -10000, ext = region_extent$Europe +) terra::plot(europe_10k) ``` @@ -737,10 +796,9 @@ In the example below we used 25 both horizontally and vertically, using bilinear interpolation. ```{r, fig.width=6, fig.height=4} -europe_ds <- terra::disagg(europe_10k, fact=25, method='bilinear') +europe_ds <- terra::disagg(europe_10k, fact = 25, method = "bilinear") terra::plot(europe_ds) - ``` -Note that, whilst we have smoothed the climate, the land mask has not changed, and thus -it still has very blocky edges. +Note that, whilst we have smoothed the climate, the land mask has not +changed, and thus it still has very blocky edges. diff --git a/vignettes/a1_available_datasets.Rmd b/vignettes/a1_available_datasets.Rmd index e3401aa9..51ca3ac2 100644 --- a/vignettes/a1_available_datasets.Rmd +++ b/vignettes/a1_available_datasets.Rmd @@ -24,20 +24,28 @@ library(pastclim) ``` ```{r echo=FALSE, results='hide'} -data_path <- file.path(tempdir(),"pastclim_data") +data_path <- file.path(tempdir(), "pastclim_data") # clear it in case it exists already -unlink(data_path, recursive = TRUE) +unlink(data_path, recursive = TRUE) # set data path -set_data_path(path_to_nc = data_path, - ask = FALSE, - write_config = FALSE, - copy_example = TRUE) +set_data_path( + path_to_nc = data_path, + ask = FALSE, + write_config = FALSE, + copy_example = TRUE +) ``` ```{r} get_available_datasets() ``` +A more comprehensive list can be obtained with: +```{r} +list_available_datasets() +``` + + For each dataset, you can get detailed information using the help function: @@ -46,12 +54,14 @@ help("Example") ``` ```{r echo=FALSE} -pastclim:::get_dataset_info(dataset="Example") +pastclim:::get_dataset_info(dataset = "Example") ``` Here we provide the full documentation for each dataset (sorted in alphabetical order): ```{r echo=FALSE} -for (i in sort(get_available_datasets())){ +list_datasets <- list_available_datasets() +list_datasets <- c(list_datasets[!grepl("WorldClim_2.1", list_datasets)], "WorldClim_2.1") +for (i in sort(list_datasets)) { pastclim:::get_dataset_info(i) cat("\n#######################################################\n") } diff --git a/vignettes/a2_custom_datasets.Rmd b/vignettes/a2_custom_datasets.Rmd index 03f056f1..03c3c09c 100644 --- a/vignettes/a2_custom_datasets.Rmd +++ b/vignettes/a2_custom_datasets.Rmd @@ -30,8 +30,8 @@ We store all the files in a single directory, and create a `spatRaster` from a l in that directory: ```{r} -tiffs_path <- system.file("extdata/CHELSA_bio01",package="pastclim") -list_of_tiffs <- file.path(tiffs_path,dir(tiffs_path)) +tiffs_path <- system.file("extdata/CHELSA_bio01", package = "pastclim") +list_of_tiffs <- file.path(tiffs_path, dir(tiffs_path)) bio01 <- terra::rast(list_of_tiffs) ``` @@ -43,45 +43,51 @@ Now we need to set the time axis of the raster (in this case, reconstructions ar ```{r} library(pastclim) -time_bp(bio01)<-c(0,-100,-200) -names(bio01)<-paste("bio01",terra::time(bio01),sep="_") +time_bp(bio01) <- c(0, -100, -200) +names(bio01) <- paste("bio01", terra::time(bio01), sep = "_") ``` Now we save the data as a *nc* file (we will use the temporary directory) ```{r} -nc_name <- file.path(tempdir(),"CHELSA_TraCE21k_bio01.nc") -terra::writeCDF(bio01, filename = nc_name, varname = "bio01", overwrite=TRUE) +nc_name <- file.path(tempdir(), "CHELSA_TraCE21k_bio01.nc") +terra::writeCDF(bio01, + filename = nc_name, varname = "bio01", + compression = 9, overwrite = TRUE +) ``` We can now read in our custom netcdf file with `pastclim`. ```{r echo=FALSE, results='hide'} -data_path <- file.path(tempdir(),"pastclim_data") +data_path <- file.path(tempdir(), "pastclim_data") # clear it in case it exists already -unlink(data_path, recursive = TRUE) +unlink(data_path, recursive = TRUE) # set data path -set_data_path(path_to_nc = data_path, - ask = FALSE, - write_config = FALSE, - copy_example = TRUE) +set_data_path( + path_to_nc = data_path, + ask = FALSE, + write_config = FALSE, + copy_example = TRUE +) ``` ```{r} -custom_series <- region_series(bio_variables = "bio01", - dataset = "custom", - path_to_nc = nc_name +custom_series <- region_series( + bio_variables = "bio01", + dataset = "custom", + path_to_nc = nc_name ) custom_series ``` As expected, there is only one variable ("bio01") and 3 time steps (nlyr). We can get the times of those time steps with: ```{r} -get_time_steps(dataset="custom", path_to_nc = nc_name) +get_time_bp_steps(dataset = "custom", path_to_nc = nc_name) ``` And we can slice the series and plot a given time point: ```{r} -climate_100<-slice_region_series(custom_series, time_bp = -100) +climate_100 <- slice_region_series(custom_series, time_bp = -100) terra::plot(climate_100) ``` @@ -99,11 +105,10 @@ to others. Here are the necessary steps: 2) Update the table used by `pastclim` to store information about available datasets. This table is found in -"./inst/extdata/variable_table.csv". +"./data-raw/data_files/dataset_list_included.csv". -```{r} -head(read.csv(system.file("extdata/dataset_list_included.csv", - package="pastclim")), n=2) +```{r echo=FALSE} +head(pastclim:::dataset_list_included, n = 2) ``` This includes the following fields: @@ -121,6 +126,11 @@ as `variable`) `download_path`: the URL to download the file. +`donwload_function`: for datasets which can be easily converted by the user into +a valid netcdf, it is possibly to leave `download_path` empty, and to create +an internal function that downloads and converts the files. For an example, see +the WorldClim datasets. + `file_name_orig`: the name of the original file(s) used to create the *nc* dataset. @@ -138,7 +148,7 @@ the *nc* dataset. `units_exp`: units formatted to be included in `expression` when creating plot labels -3) Once you have added lines detailing the variables in your dataset, run the script "./raw-data/dataset_list_included.R" to store +3) Once you have added lines detailing the variables in your dataset, run the script "./raw-data/make_data/dataset_list_included.R" to store that information into the appropriate dataset in `pastclim`. 4) Provide information on the new dataset in the file "./R/dataset_docs", using `roxygen2` syntax. Make sure that you provide an appropriate reference for the original data, as it is important that users can refer back to the original source. diff --git a/vignettes/a3_pastclim_present_and_future.Rmd b/vignettes/a3_pastclim_present_and_future.Rmd new file mode 100644 index 00000000..f6fd92e9 --- /dev/null +++ b/vignettes/a3_pastclim_present_and_future.Rmd @@ -0,0 +1,124 @@ +--- +title: "present and future" +# output: rmarkdown::pdf_document +output: rmarkdown::html_vignette +vignette: > + %\VignetteIndexEntry{present and future} + %\VignetteEncoding{UTF-8} + %\VignetteEngine{knitr::rmarkdown} +editor_options: + markdown: + wrap: 72 +--- + +```{r, include = FALSE} +knitr::opts_chunk$set( + collapse = TRUE, + comment = "#>" +) +``` + + +Whilst `pastclim` is mostly designed to handle palaeoclimate time series, it can +also be used to manipulate present reconstructions and future projections. +Currently, it uses the WorldClim datasets, but it could easily be adapted to +use other sources such as CHELSA. + +# Present reconstructions + +Present-day reconstructions for WorldClim v2.1 are based on the mean for the period 1970-2000, +and are available at multiple resolutions of +10 arc-minutes, 5 arc-minutes, 2.5 arc-minute and 0.5 arc-minutes. The resolution +of interest can be obtained by changing the ending of the dataset name +*WorldClim_2.1_RESm*, e.g. *WorldClim_2.1_10m* or *WorldClim_2.1_5m* +(currently, only 10m and 5m are currently available in `pastclim`). In `pastclim`, the datasets are given +a date of 1985 CE (the mid-point of the period of interest), corresponding to +a time_bp of 35. There are 19 “bioclimatic” variables, as well as monthly +estimates for minimum, mean, and maximum temperature, and precipitation. + +So, the annual variables for the 10m arc-minutes dataset are: +```{r} +library(pastclim) +get_vars_for_dataset("WorldClim_2.1_10m") +``` + +And the monthly variables +```{r} +get_vars_for_dataset("WorldClim_2.1_10m", monthly = TRUE, annual = FALSE) +``` + +We can manipulate data in the usual way. We start by downloading the dataset: +```{r eval=FALSE} +download_dataset( + dataset = "WorldClim_2.1_10m", + bio_variables = c("bio01", "bio02", "altitude") +) +``` + +We can then use `region_slice` to extract the data as a `SpatRaster`: +```{r eval=FALSE} +climate_present <- region_slice( + time_ce = 1985, + bio_variables = c("bio01", "bio02", "altitude"), + dataset = "WorldClim_2.1_10m" +) +``` + +# Future projections + +Future projections are based on the models in CMIP6, downscaled and de-biased +using WorldClim 2.1 for the present as a baseline. Monthly values of minimum +temperature, maximum temperature, and precipitation, as well as 19 bioclimatic +variables were processed for +23 global climate models (GCMs), and for four +Shared Socio-economic Pathways (SSPs): 126, 245, 370 and 585. Model and +SSP can be chosen by changing the ending of the dataset name +*WorldClim_2.1_GCM_SSP_RESm*. + +A complete list of available combinations can be obtained with: +```{r} +list_available_datasets() +``` + +So, if we are interested in the the HadGEM3-GC31-LL model, with ssp set +to 245 and at 10 arc-minutes, we can get the available variables: + +```{r} +get_vars_for_dataset(dataset = "WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m") +``` + +We can now download "bio01" and "bio02" for that dataset with: +```{r eval=FALSE} +download_dataset( + dataset = "WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m", + bio_variables = c("bio01", "bio02") +) +``` + +The dataset are averages over 20 year +periods (2021-2040, 2041-2060, 2061-2080, 2081-2100). +In `pastclim`, the midpoints of the periods (2030, 2050, 2070, 2090) are used as the time stamps. All 4 periods +are automatically downloaded for each combination of GCM model and SSP, and can +be selected +as usual by defining the time in `region_slice`. + +```{r eval=FALSE} +future_slice <- region_slice( + time_ce = 2030, + dataset = "WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m", + bio_variables = c("bio01", "bio02") +) +``` + +Alternatively, it is possible to get the full time series of 4 slices with: +```{r eval=FALSE} +future_series <- region_series( + dataset = "WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m", + bio_variables = c("bio01", "bio02") +) +``` + +It is possible to simply use `time_ce(dataset = "WorldClim_2.1_HadGEM3-GC31-LL_ssp245_10m")` to get the available time points for +that dataset. + +Help for the WorldClim datasets (modern and future) can be accessed with `help("WorldClim_2.1")`