code
stringlengths
1
13.8M
HWGenotypePlot <- function(X,plottype=1,xlab=expression(f[AA]),ylab=ifelse(plottype==1,expression(f[AB]), expression(f[BB])),asp=1,pch=19,xlim=c(0,1),ylim=c(0,1),cex=1,cex.axis=2,cex.lab=2,...) { if (is.vector(X)) { if (length(X) != 3) { stop("X must have three elements") } else { X <- matrix(X, ncol = 3, dimnames = list(c("1"), names(X))) } } nr <- nrow(X) nc <- ncol(X) if (any(X < 0)) stop("X must be non-negative") if (nc != 3) stop("X must have three columns") if (nrow(X) == 1) { Xcom <- X/sum(X) } else { Xcom <- HWClo(X) } fAA <- seq(0,1,by=0.01) fAB <- 2*(sqrt(fAA)-fAA) fBB <- (1-sqrt(fAA))^2 if(is.element(plottype,c(1,2))) { opar <- par(mar=c(5,5,2,1)) if(plottype==1) { plot(Xcom[,1],Xcom[,2],pch=pch,xlim=xlim,ylim=ylim,xlab=xlab,ylab=ylab,cex=cex,cex.axis=cex.axis,cex.lab=cex.lab,...) lines(c(0,1),c(1,0),lwd=2,col="red") points(fAA,fAB,pch=19,col="blue",type="l",lwd=2) } if(plottype==2) { plot(Xcom[,1],Xcom[,3],pch=pch,xlim=xlim,ylim=ylim,xlab=xlab,ylab=ylab,cex=cex,cex.axis=cex.axis,cex.lab=cex.lab,...) lines(c(0,1),c(1,0),lwd=2,col="red") points(fAA,fBB,pch=19,col="blue",type="l",lwd=2) } par(opar) } else stop("HWGenotypePlot: invalid argument for plottype") return(NULL) }
BP2D_coef <- function(result) { if (class(result) == "BP2D_result") { len_coef <- list() for (j in seq_len(length(result$store_coefficient))) { len_coef[[j]] <- sapply(result$store_coefficient[[j]], length) } len_coef <- do.call(cbind, len_coef) store_coef <- lapply(result$store_coef, unlist) max_len <- max(sapply(store_coef, length)) store_coef <- sapply(store_coef, function(x) c(x, rep(NA, max_len - length(x)))) colnames(len_coef) <- colnames(store_coef) <- names(result$store_coefficient) row.names(len_coef) <- seq_len(nrow(len_coef)) row.names(store_coef) <- seq_len(nrow(store_coef)) return(list(store_coefficient = store_coef, len_coefficient = len_coef)) } else { stop("Please check your input and try again") } }
euclidean.compy.f <- function(modsite, fossite){ return(fossite[2]- modsite[2]) }
Read_Results <- function(file, node = "pre") { if (stringr::str_detect(file, "\\.pdf$|\\.aspx$") == TRUE) { results <- pdftools::pdf_text(file) as_lines <- stringr::str_extract_all(results, "\n.*") as_lines_list_2 <- unlist(as_lines, recursive = FALSE) as_lines_list_2 <- read_results_flag(as_lines_list_2) return(as_lines_list_2) } else if (stringr::str_detect(file, "\\.htm") == TRUE) { if (is.character(node) == FALSE) { stop(" Please supply a value for node") } else { webpage <- xml2::read_html(file) html <- rvest::html_nodes(webpage, node) results <- rvest::html_text(html) as_lines <- stringr::str_extract_all(results, "\n.*") as_lines_list_2 <- unlist(as_lines, recursive = FALSE) as_lines_list_2 <- read_results_flag(as_lines_list_2) return(as_lines_list_2) } } else if (stringr::str_detect(file, "\\.hy3") == TRUE) { results <- readr::read_delim(file, delim = "\\s\\2", col_names = FALSE) as_lines_list_2 <- unlist(results, recursive = FALSE) as_lines_list_2 <- read_results_flag(as_lines_list_2) row_numbs <- seq(1, length(as_lines_list_2), 1) as_lines_list_2 <- paste(as_lines_list_2, row_numbs, sep = " ") return(as_lines_list_2) } else { stop("Please supply a valid .html, .hy3 or .pdf document") } } read_results <- Read_Results read_results_flag <- function(x){ x <- c("read_results_flag", x) }
validate_colours <- function(x, on_invalid = stop) { validation <- is_colour(x) n_invalid <- sum(!validation) if (n_invalid == 1) { on_invalid(x[!validation], ' is not a valid colour.', call. = FALSE) } else if (n_invalid > 1) { on_invalid(display_list(x[!validation]), ' are not valid colours.', call. = FALSE) } }
blandr.plot.ggplot <- function ( statistics.results , method1name = "Method 1" , method2name = "Method 2" , plotTitle = "Bland-Altman plot for comparison of 2 methods" , ciDisplay = TRUE , ciShading = TRUE , normalLow = FALSE , normalHigh = FALSE , overlapping = FALSE , x.plot.mode = "means" , y.plot.mode = "difference" , plotProportionalBias = FALSE , plotProportionalBias.se = TRUE , assume.differences.are.normal = TRUE ) { if (!requireNamespace("ggplot2", quietly = TRUE)) { stop("Package \"ggplot2\" needed for this function to work. Please install it.", call. = FALSE) } x.axis <- statistics.results$means if( y.plot.mode == "proportion" ) { y.axis <- statistics.results$proportion } else { y.axis <- statistics.results$differences } plot.data <- data.frame( x.axis , y.axis ) colnames(plot.data)[1] <- "x.axis" colnames(plot.data)[2] <- "y.axis" ba.plot <- ggplot( plot.data , aes( x = plot.data$x.axis , y = plot.data$y.axis ) ) + geom_point() + theme(plot.title = element_text(hjust = 0.5)) + geom_hline( yintercept = 0 , linetype = 1 ) + geom_hline( yintercept = statistics.results$bias , linetype = 2 ) + geom_hline( yintercept = statistics.results$bias + ( statistics.results$biasStdDev * statistics.results$sig.level.convert.to.z ) , linetype = 2 ) + geom_hline( yintercept = statistics.results$bias - ( statistics.results$biasStdDev * statistics.results$sig.level.convert.to.z ) , linetype = 2 ) + ggtitle( plotTitle ) + xlab( "Means" ) if ( y.plot.mode == "proportion" ) { ba.plot <- ba.plot + ylab( "Difference / Average %" ) } else { ba.plot <- ba.plot + ylab( "Differences" ) } if( ciDisplay == TRUE ) { ba.plot <- ba.plot + geom_hline( yintercept = statistics.results$biasUpperCI , linetype = 3 ) + geom_hline( yintercept = statistics.results$biasLowerCI , linetype = 3 ) + geom_hline( yintercept = statistics.results$upperLOA_upperCI , linetype = 3 ) + geom_hline( yintercept = statistics.results$upperLOA_lowerCI , linetype = 3 ) + geom_hline( yintercept = statistics.results$lowerLOA_upperCI , linetype = 3 ) + geom_hline( yintercept = statistics.results$lowerLOA_lowerCI , linetype = 3 ) if( ciShading == TRUE ) { ba.plot <- ba.plot + annotate( "rect", xmin = -Inf , xmax = Inf , ymin = statistics.results$biasLowerCI , ymax = statistics.results$biasUpperCI , fill="blue" , alpha=0.3 ) + annotate( "rect", xmin = -Inf , xmax = Inf , ymin = statistics.results$upperLOA_lowerCI , ymax = statistics.results$upperLOA_upperCI , fill="green" , alpha=0.3 ) + annotate( "rect", xmin = -Inf , xmax = Inf , ymin = statistics.results$lowerLOA_lowerCI , ymax = statistics.results$lowerLOA_upperCI , fill="red" , alpha=0.3 ) } } if( normalLow != FALSE ) { if( is.numeric(normalLow) == TRUE ) { ba.plot <- ba.plot + geom_vline( xintercept = normalLow , linetype = 4 , col=6 ) } } if( normalHigh != FALSE ) { if( is.numeric(normalHigh) == TRUE ) { ba.plot <- ba.plot + geom_vline( xintercept = normalHigh , linetype = 4 , col=6 ) } } if( overlapping == TRUE ) { ba.plot <- ba.plot + geom_count() } if( plotProportionalBias == TRUE ) { if( plotProportionalBias.se !=TRUE && plotProportionalBias.se != FALSE) { plotProportionalBias.se <- TRUE } ba.plot <- ba.plot + ggplot2::geom_smooth( method = 'lm' , se = plotProportionalBias.se ) } return(ba.plot) }
NULL setClass("DamerauLevenshtein", contains = "Levenshtein", slots = c(transposition = "numeric"), prototype = structure( .Data = function(x, y, ...) elementwise(sys.function(), x, y, ...), transposition = 1.0 ), validity = function(object) { errs <- character() if (object@transposition < 0 | length(object@transposition) != 1) errs <- c(errs, "`transposition` must be a non-negative numeric vector of length 1") ifelse(length(errs) == 0, TRUE, errs) }) DamerauLevenshtein <- function(deletion = 1.0, insertion = 1.0, substitution = 1.0, transposition = 1.0, normalize = FALSE, similarity = FALSE, ignore_case = FALSE, use_bytes = FALSE) { arguments <- c(as.list(environment())) arguments$similarity <- similarity arguments$distance <- !similarity arguments$symmetric <- deletion == insertion arguments$tri_inequal <- deletion == insertion & !similarity do.call("new", append("DamerauLevenshtein", arguments)) }
bootstrapSoilTexture <- function(ssc, method = c('dirichlet', 'normal'), n = 100) { if(!requireNamespace("compositions", quietly = TRUE)) stop("package `compositions` is required", call.=FALSE) ssc <- na.omit(ssc) method <- match.arg(method) if(ncol(ssc) < 3 | nrow(ssc) < 3) { stop('insufficient observations or incorrect column specification', call. = FALSE) } name.check <- sapply(c('SAND', 'SILT', 'CLAY'), function(i) { any(names(ssc) %in% i) }) if(! all(name.check)) { stop('`ssc` must contain columns: `SAND`, `SILT`, `CLAY`.') } ssc <- ssc[, c('SAND', 'SILT', 'CLAY')] range.check <- range(sapply(ssc, range)) if(! all(range.check >= 0 & range.check < 100)) { stop('data should be in the range of 0 to 100 (%)', call. = FALSE) } z <- compositions::acomp(ssc, total = 100) mean.comp <- compositions::meanCol(z) var.comp <- compositions::var(z, robust = FALSE, method = 'pearson') s <- switch( method, 'normal' = { D <- NULL compositions::rnorm.acomp( n = n, mean = mean.comp, var = var.comp ) }, 'dirichlet' = { el <- compositions::mean.rmult(compositions::ult(z), robust = FALSE) D <- compositions::fitDirichlet(z, elog = el)$alpha compositions::rDirichlet.acomp(n = n, alpha = D) } ) s <- as.data.frame(unclass(s) * 100) names(s) <- names(ssc) res <- list( samples = s, mean = mean.comp, var = var.comp, D.alpha = D ) return(res) }
expected <- eval(parse(text="TRUE")); test(id=0, code={ argv <- eval(parse(text="list(function (object) TRUE)")); .Internal(`body`(argv[[1]])); }, o=expected);
library(gtools) today <- Sys.Date() tenweeks <- seq(today, length.out = 10, by = "1 week") df1 <- data.frame(dates = tenweeks, chars = letters[1:10], ints = 1:10, numeric = 1.1:10.1) df2 <- data.frame(chars = letters[11:20], ints = 11:20, numeric = 11.1:20.1) smartbind(df1, df2)
determine_mapping <- function(df, ..., listviewer = TRUE){ df %>% framecleaner::select_otherwise(..., otherwise = tidyselect::everything(), return_type = "df") %>% dplyr::ungroup(.) -> df1 if(ncol(df1) < 2){ rlang::abort("insufficient non-unique columns") } cnf_output <- list() for(i in 2:ncol(df1)){ for(j in 1:(i-1)){ nm1 <- rlang::sym(names(df1)[i]) nm2 <- rlang::sym(names(df1)[j]) cnf_output <- append(cnf_output, utils::capture.output(suppressMessages(confirm_mapping(df1, !!nm1, !!nm2, view = F))) ) } } cnf_output %>% unlist -> cnf_output1 list_output <- list() list_output[["1 - 1 mapping"]] <- stringr::str_subset(cnf_output1, "1 - 1 mapping") %>% stringr::str_remove(., "1 - 1 mapping between ") list_output[["1 - many mapping"]] <- stringr::str_subset(cnf_output1, "1 - many mapping") %>% stringr::str_remove(., "1 - many mapping between ") list_output[["many - 1 mapping"]] <- stringr::str_subset(cnf_output1, "many - 1 mapping") %>% stringr::str_remove(., "many - 1 mapping between ") list_output[["many - many mapping"]] <- stringr::str_subset(cnf_output1, "many - many mapping") %>% stringr::str_remove(., "many - many mapping between ") if(listviewer){ listviewer::jsonedit(list_output)} else { list_output } }
sanity_model_specific <- function (model, ...) { UseMethod("sanity_model_specific", model) } sanity_model_specific.default <- function(model, ...) { return(invisible(NULL)) } sanity_model_supported_class <- function(model) { supported <- list("betareg", "bife", "brglmFit", "brmsfit", c("bracl", "brmultinom", "brglmFit"), c("brnb", "negbin", "glm"), "clm", "coxph", "crch", "fixest", c("Gam", "glm", "lm"), c("gam", "glm", "lm"), c("geeglm", "gee", "glm"), "glm", "gls", "glmerMod", "glmrob", c("glmmPQL", "lme"), "glimML", "glmx", "hurdle", "hxlr", "ivreg", "iv_robust", "lm", "lmerMod", "lmerModLmerTest", "lmrob", "lmRob", "lm_robust", "loess", c("lrm", "lm"), c("lrm", "rms", "glm"), c("mblogit", "mclogit"), c("mclogit", "lm"), c("multinom", "nnet"), c("negbin", "glm", "lm"), c("plm", "panelmodel"), "polr", "rlmerMod", "rq", c("scam", "glm", "lm"), "speedglm", "speedlm", "stanreg", c("tobit", "survreg"), "truncreg", "zeroinfl") flag <- FALSE for (sup in supported) { if (all(sup %in% class(model))) { flag <- TRUE } } if (isFALSE(flag)) { support <- paste(sort(unique(sapply(supported, function(x) x[1]))), collapse = ", ") msg <- 'Models of class "%s" are not supported. Supported model classes include: %s. New modeling packages can usually be supported by `marginaleffects` if they include a working `predict()` method. If you believe that this is the case, please file a feature request on Github: https://github.com/vincentarelbundock/marginaleffects/issues' msg <- sprintf(msg, class(model)[1], support) stop(msg) } } sanity_model <- function(model, ...) { sanity_model_specific(model, ...) sanity_model_supported_class(model) return(model) }
mergeDocumentation <- function(x) { if(!anyDuplicated(names(x))) return(x) out <- list() for(i in unique(names(x))) { out[[i]] <- unlist(x[names(x)==i], use.names=FALSE) } return(out) }
met.geodesic <- function(M, weighted = TRUE, shortest.weight = FALSE, normalization = TRUE, directed = TRUE, out = TRUE) { test <- is.matrix(M) if (test) { result <- met.geodesicDiameter.single(M, weighted, shortest.weight, normalization, directed, out)[[2]] return(result) } else { if (!is.null(attributes(M)$ANT)) { test1 <- attributes(M)$ANT == "list of matrices obtained through data frames of interactions" if(test1){ result <- lapply(M, function(x, weighted, shortest.weight, normalization, directed, out) { r <- met.geodesicDiameter.single(x, weighted = weighted, shortest.weight = shortest.weight, normalization = normalization, directed = directed, out = out)[[2]] }, weighted = weighted, shortest.weight = shortest.weight, normalization = normalization, directed = directed, out = out) return(result) } else{ stop("Geodesic distances is a matrix and cannot be analyse on ANTs analyticial protocols ") } } else { if (!test & is.list(M)) { result <- lapply(M, function(x, weighted, shortest.weight, normalization, directed, out) { r <- met.geodesicDiameter.single(x, weighted = weighted, shortest.weight = shortest.weight, normalization = normalization, directed = directed, out = out)[[2]] }, weighted = weighted, shortest.weight = shortest.weight, normalization = normalization, directed = directed, out = out) return(result) } } } }
IPA_TargetedAnalysis <- function(spreadsheet, mzCandidate, rtCandidate, exportEIC = TRUE, exportTable = FALSE) { cc_table <- c() if (length(mzCandidate) != length(rtCandidate)) { stop("Error!!! mz and rt vectors do not have the same length!") } PARAM <- xlsxAnalyzer_EIC(spreadsheet) if (length(PARAM) > 0) { number_processing_cores <- as.numeric(PARAM[which(PARAM[, 1] == 'PARAM0006'), 2]) input_path_hrms <- PARAM[which(PARAM[, 1] == 'PARAM0007'), 2] if (tolower(PARAM[which(PARAM[, 1] == 'PARAM0008'), 2]) == "all") { file_name_hrms <- dir(path = input_path_hrms) file_name_hrms <- file_name_hrms[grep(paste0(".", tolower(PARAM[which(PARAM[, 1] == 'PARAM0009'), 2]), "$"), file_name_hrms, ignore.case = TRUE)] } else { samples_string <- PARAM[which(PARAM[, 1] == 'PARAM0008'), 2] file_name_hrms <- strsplit(samples_string, ";")[[1]] } output_path <- PARAM[which(PARAM[, 1] == 'PARAM0010'), 2] if (!dir.exists(output_path)) { print("Created output directory!") dir.create(output_path) } output_path_eic <- paste0(output_path, "/EICs") if (!dir.exists(output_path_eic)) { dir.create(output_path_eic) } opendir(output_path_eic) if (exportEIC == TRUE) { img <- png::readPNG(paste0(system.file("extdata", package = "IDSL.IPA"),"/EIC_legend.png")) legend_EIC <- grid::rasterGrob(img, interpolate = TRUE) } max_ratio_13c <- as.numeric(PARAM[which(PARAM[, 1] == 'PARAM0012'), 2]) mass_accuracy_xic <- as.numeric(PARAM[which(PARAM[, 1] == 'PARAM0013'), 2]) mass_accuracy_13c <- 1.5*mass_accuracy_xic smoothing_window <- as.numeric(PARAM[which(PARAM[, 1] == 'PARAM0015'), 2]) peak_resolving_power <- as.numeric(PARAM[which(PARAM[, 1] == 'PARAM0017'), 2]) scan_tol <- as.numeric(PARAM[which(PARAM[, 1] == 'PARAM0020'), 2]) n_spline <- as.numeric(PARAM[which(PARAM[, 1] == 'PARAM0028'), 2]) R0 <- c(1, 2, 4, 5, 6, 7, 9, 14, 24) R3 <- c(3, 11, 12, 13, 14, 15, 16, 17, 18, 19, 20, 21, 22, 23) R5 <- c(8, 10) osType <- Sys.info()[['sysname']] print("Initiated the targeted analysis!") if(osType == "Windows") { cl <- makeCluster(number_processing_cores) registerDoSNOW(cl) cc_table <- foreach(i = 1:length(file_name_hrms), .combine ='rbind', .verbose = FALSE) %dopar% { MassSpec_file <- paste0(input_path_hrms, "/", file_name_hrms[i]) outputer <- MS_deconvoluter(MassSpec_file) spectraList <- outputer[[1]] RetentionTime <- outputer[[2]] nRT <- length(RetentionTime) chrome <- do.call(rbind, lapply(1:length(mzCandidate), function(j) { ScanNumberApex <- which.min(abs(RetentionTime - rtCandidate[j])) t1 <- ScanNumberApex - scan_tol if (t1 < 1) { t1 <- 1 } t2 <- ScanNumberApex + scan_tol if (t2 > nRT) { t2 <- nRT } chromatogram_segment <- do.call(rbind, lapply(t1:t2, function(t) { Spec_ScN_j <- c() Spec <- spectraList[[t]] if (length(Spec) > 0) { x_mz1 <- which(abs(Spec[, 1] - mzCandidate[j]) <= mass_accuracy_xic) if (length(x_mz1) > 0) { x_mz2 <- which(abs(Spec[, 1] - (1.00335484 + mzCandidate[j])) <= mass_accuracy_13c) if (length(x_mz2) > 0) { if (length(x_mz1) > 1) { x_min <- which.min(abs(Spec[x_mz1, 1] - mzCandidate[j])) x_mz1 <- x_mz1[x_min] } if (length(x_mz2) > 1) { x_min <- which.min(abs(Spec[x_mz2, 1] - (1.00335484 + mzCandidate[j]))) x_mz2 <- x_mz2[x_min] } if (Spec[x_mz2, 2]/Spec[x_mz1, 2] <= max_ratio_13c/100) { Spec_ScN_j <- c(Spec[x_mz1, 1], Spec[x_mz1, 2], t, Spec[x_mz2, 1], Spec[x_mz2, 2]) } } } } Spec_ScN_j })) if (length(chromatogram_segment) != 0) { chromatogram_segment <- chromatogram_segment[order(chromatogram_segment[, 3]), ] chromatogram_segment <- matrix(chromatogram_segment, ncol = 5) } else { chromatogram_segment <- matrix(c(mzCandidate[j], mzCandidate[j], 0 , 0 , t1, t2, 0, 0, 0, 0), ncol = 5) } if (chromatogram_segment[1, 3] != t1) { chromatogram_segment <- rbind(c(mzCandidate[j], 0, t1, 0, 0), chromatogram_segment) } if (chromatogram_segment[dim(chromatogram_segment)[1], 3] != t2) { chromatogram_segment <- rbind(chromatogram_segment, c(mzCandidate[j], 0, t2, 0, 0)) } peak_property <- chromatography_analysis(chromatogram_segment, smoothing_window, peak_resolving_power, min_nIsoPair = 0, min_peak_height = 0, min_ratio_IsoPair = 0, max_rpw = 1, min_snr_baseline = 0, max_R13C_integrated_peak = Inf, max_percentage_missing_scans = Inf, mz_target = mzCandidate[j], rt_target = rtCandidate[j], mass_accuracy_xic, spectraList, RetentionTime, n_spline) if (length(peak_property) > 0) { peak_property <- matrix(peak_property, ncol = 1) peak_property[R0] <- round(peak_property[R0], 0) peak_property[R3] <- round(peak_property[R3], 3) peak_property[R5] <- round(peak_property[R5], 5) peak_property_xic <- c(peak_property[3], peak_property[8], peak_property[10], mass_accuracy_xic, peak_property[1:2], peak_property[4:7], peak_property[9], peak_property[11:24]) peak_property_xic <- data.frame(peak_property_xic) colnames(peak_property_xic) <- "" rownames(peak_property_xic) <- c("Retention time (min)", "m/z (monoisotopic)", "m/z (13C)", "Mass tolerance (Da)", "Scan (start)", "Scan (end)", "Peak height", "Peak area", "nIsoPair", "RCS(%)", "Cumulative intensity", "R13C (%)", "Peak width @ baseline", "Ratio peak width @ 50%", "Separation trays", "Asymmetry factor @ 10%", "USP tailing factor @ 5%", "Skewness derivative method", "Symmetry pseudo-moments", "Skewness pseudo-moments", "Gaussianity", "S/N baseline", "S/N xcms method", "S/N RMS", "Sharpness") if (exportEIC == TRUE) { EIC_figure <- EIC_plotter(chromatogram_segment, peak_property_xic, smoothing_window, peak_resolving_power, mass_accuracy_xic, spectraList, RetentionTime, mz_target = mzCandidate[j], rt_target = rtCandidate[j], file_name = file_name_hrms[i], legend_EIC) ggsave(filename=paste0("/IPA_EIC_", file_name_hrms[i], "_", j, "_", round(mzCandidate[j], 5), "_",round(rtCandidate[j], 2), ".png"), plot = EIC_figure, device = "png", path = output_path_eic, scale = 1, width = 16, height = 8, units = "in", dpi = 100) } } else { peak_property <- rep(0, 24) } cbind(file_name_hrms[i], round(mzCandidate[j], 5), round(rtCandidate[j], 2), data.frame(matrix(peak_property, nrow = 1))) })) chrome } stopCluster(cl) } if (osType == "Linux") { cc_table <- do.call(rbind, lapply(1:length(file_name_hrms), function(i) { MassSpec_file <- paste0(input_path_hrms, "/", file_name_hrms[i]) outputer <- MS_deconvoluter(MassSpec_file) spectraList <- outputer[[1]] RetentionTime <- outputer[[2]] nRT <- length(RetentionTime) chrome <- do.call(rbind, mclapply(1:length(mzCandidate), function(j) { ScanNumberApex <- which.min(abs(RetentionTime - rtCandidate[j])) t1 <- ScanNumberApex - scan_tol if (t1 < 1) { t1 <- 1 } t2 <- ScanNumberApex + scan_tol if (t2 > nRT) { t2 <- nRT } chromatogram_segment <- do.call(rbind, lapply(t1:t2, function(t) { Spec_ScN_j <- c() Spec <- spectraList[[t]] if (length(Spec) > 0) { x_mz1 <- which(abs(Spec[, 1] - mzCandidate[j]) <= mass_accuracy_xic) if (length(x_mz1) > 0) { x_mz2 <- which(abs(Spec[, 1] - (1.00335484 + mzCandidate[j])) <= mass_accuracy_13c) if (length(x_mz2) > 0) { if (length(x_mz1) > 1) { x_min <- which.min(abs(Spec[x_mz1, 1] - mzCandidate[j])) x_mz1 <- x_mz1[x_min] } if (length(x_mz2) > 1) { x_min <- which.min(abs(Spec[x_mz2, 1] - (1.00335484 + mzCandidate[j]))) x_mz2 <- x_mz2[x_min] } if (Spec[x_mz2, 2]/Spec[x_mz1, 2] <= max_ratio_13c/100) { Spec_ScN_j <- c(Spec[x_mz1, 1], Spec[x_mz1, 2], t, Spec[x_mz2, 1], Spec[x_mz2, 2]) } } } } Spec_ScN_j })) if (length(chromatogram_segment) != 0) { chromatogram_segment <- chromatogram_segment[order(chromatogram_segment[, 3]), ] chromatogram_segment <- matrix(chromatogram_segment, ncol = 5) } else { chromatogram_segment <- matrix(c(mzCandidate[j], mzCandidate[j], 0 , 0 , t1, t2, 0, 0, 0, 0), ncol = 5) } if (chromatogram_segment[1, 3] != t1) { chromatogram_segment <- rbind(c(mzCandidate[j], 0, t1, 0, 0), chromatogram_segment) } if (chromatogram_segment[dim(chromatogram_segment)[1], 3] != t2) { chromatogram_segment <- rbind(chromatogram_segment, c(mzCandidate[j], 0, t2, 0, 0)) } peak_property <- chromatography_analysis(chromatogram_segment, smoothing_window, peak_resolving_power, min_nIsoPair = 0, min_peak_height = 0, min_ratio_IsoPair = 0, max_rpw = 1, min_snr_baseline = 0, max_R13C_integrated_peak = Inf, max_percentage_missing_scans = Inf, mz_target = mzCandidate[j], rt_target = rtCandidate[j], mass_accuracy_xic, spectraList, RetentionTime, n_spline) if (length(peak_property) > 0) { peak_property <- matrix(peak_property, ncol = 1) peak_property[R0] <- round(peak_property[R0], 0) peak_property[R3] <- round(peak_property[R3], 3) peak_property[R5] <- round(peak_property[R5], 5) peak_property_xic <- c(peak_property[3], peak_property[8], peak_property[10], mass_accuracy_xic, peak_property[1:2], peak_property[4:7], peak_property[9], peak_property[11:24]) peak_property_xic <- data.frame(peak_property_xic) colnames(peak_property_xic) <- "" rownames(peak_property_xic) <- c("Retention time (min)", "m/z (monoisotopic)", "m/z (13C)", "Mass tolerance (Da)", "Scan (start)", "Scan (end)", "Peak height", "Peak area", "nIsoPair", "RCS(%)", "Cumulative intensity", "R13C (%)", "Peak width @ baseline", "Ratio peak width @ 50%", "Separation trays", "Asymmetry factor @ 10%", "USP tailing factor @ 5%", "Skewness derivative method", "Symmetry pseudo-moments", "Skewness pseudo-moments", "Gaussianity", "S/N baseline", "S/N xcms method", "S/N RMS", "Sharpness") if (exportEIC == TRUE) { EIC_figure <- EIC_plotter(chromatogram_segment, peak_property_xic, smoothing_window, peak_resolving_power, mass_accuracy_xic, spectraList, RetentionTime, mz_target = mzCandidate[j], rt_target = rtCandidate[j], file_name = file_name_hrms[i], legend_EIC) ggsave(filename=paste0("/IPA_EIC_", file_name_hrms[i], "_", j, "_", round(mzCandidate[j], 5), "_",round(rtCandidate[j], 2), ".png"), plot = EIC_figure, device = "png", path = output_path_eic, scale = 1, width = 16, height = 8, units = "in", dpi = 100) } } else { peak_property <- rep(0, 24) } cbind(file_name_hrms[i], round(mzCandidate[j], 5), round(rtCandidate[j], 2), data.frame(matrix(peak_property, nrow = 1))) }, mc.cores = number_processing_cores)) chrome })) closeAllConnections() } print("Completed the targeted analysis!") } if (exportTable == TRUE) { if (length(cc_table) > 0) { cc_table <- data.frame(cc_table) names(cc_table) <- c("Name HRMS", "m/z candidate", "RT candidate", "ScanNumberStart","ScanNumberEnd","RetentionTimeApex","PeakHeight","PeakArea", "NumberDetectedScans(nIsoPair)","RCS(%)","m/z MonoIsotopic","CumulatedIntensity", "m/z 13C","Ratio 13C CumulatedIntensity","PeakWidthBaseline","Ratio PeakWidth @ 50%", "SeperationTray","AsymmetryFactor @ 10%","USPTailingFactor @ 5%", "Skewness_DerivativeMethod", "Symmetry PseudoMoments","Skewness PseudoMoments", "Gaussianity", "S/N baseline", "S/N xcms method", "S/N RMS", "Sharpness") rownames(cc_table) <- c() save(cc_table, file = paste0(output_path, "/exportTable.Rdata")) write.csv(cc_table, file = paste0(output_path, "/exportTable.csv")) } } }
FunctionImputation <- R6Class("FunctionImputation", inherit = DistributionDecorator, public = list( packages = c("pracma", "GoFKernel"), decorate = function(distribution, n = 1000) { assert_pkgload(self$packages) if (!testUnivariate(distribution)) { stop("FunctionImputation is currently only supported for univariate distributions.") } if ("FunctionImputation" %in% distribution$decorators) { message(paste(distribution$name, "is already decorated with FunctionImputation.")) invisible(self) } else { pdist <- distribution$.__enclos_env__$private pdist$.log <- TRUE pdist$n_grid <- checkmate::assertIntegerish(n) if (!isPdf(distribution)) { pdf <- FunctionImputation$private_methods$.pdf formals(pdf) <- c(formals(pdf), list(self = distribution, private = pdist)) pdist$.pdf <- pdf pdist$.isPdf <- -1L } if (!isCdf(distribution)) { cdf <- FunctionImputation$private_methods$.cdf formals(cdf) <- c(formals(cdf), list(self = distribution, private = pdist)) pdist$.cdf <- cdf pdist$.isCdf <- -1L } if (!isQuantile(distribution)) { quantile <- FunctionImputation$private_methods$.quantile formals(quantile) <- c(formals(quantile), list(self = distribution, private = pdist)) pdist$.quantile <- quantile pdist$.isQuantile <- -1L } if (!isRand(distribution)) { rand <- FunctionImputation$private_methods$.rand formals(rand) <- c(formals(rand), list(self = distribution, private = pdist)) pdist$.rand <- rand pdist$.isRand <- -1L } message(paste(distribution$name, "is now decorated with FunctionImputation.")) pdist$.updateDecorators(c(distribution$decorators, "FunctionImputation")) invisible(self) } } ), active = list( methods = function() { names(private) } ), private = list( .pdf = function(x, log = FALSE) { if (testDiscrete(self)) { data <- matrix(x, ncol = 1) pdf <- self$cdf(data = data) - self$cdf(data = data - 1) } else if (testContinuous(self)) { message(.distr6$message_numeric) pdf <- pracma::fderiv(self$cdf, x) } if (log) { pdf <- log(pdf) } return(pdf) }, .cdf = function(x, lower.tail = TRUE, log.p = FALSE) { message(.distr6$message_numeric) if (testDiscrete(self)) { grid_x <- impute_genx(self, private$n_grid) cdf <- C_NumericCdf_Discrete( q = x, x = grid_x, pdf = self$pdf(grid_x), lower = lower.tail, logp = log.p ) } else { cdf <- numeric(length(x)) for (i in seq_along(x)) { cdf[i] <- integrate(self$pdf, self$properties$support$lower, x[i])$value } } return(cdf) }, .quantile = function(p, lower.tail = TRUE, log.p = FALSE) { message(.distr6$message_numeric) data <- p if (testContinuous(self)) { x <- self$workingSupport() lower <- x$lower upper <- x$upper quantile <- numeric(length(data)) for (i in seq_along(data)) { quantile[i] <- suppressMessages(GoFKernel::inverse(self$cdf, lower = lower, upper = upper )(data[i])) } } else { x <- impute_genx(self, private$n_grid) if (isCdf(self) == 1L) { quantile <- suppressMessages(C_NumericQuantile(data, x, self$cdf(x), lower.tail, log.p)) } else { cdf <- suppressMessages(C_NumericCdf_Discrete(x, x, self$pdf(x), lower = TRUE, logp = FALSE )) quantile <- C_NumericQuantile(data, x, cdf, lower.tail, log.p) } } return(quantile) }, .rand = function(n) { message(.distr6$message_numeric) if (isQuantile(self) == 1L) { return(self$quantile(runif(n))) } else if (isPdf(self) == 1L) { x <- impute_genx(self, private$n_grid) return(sample(x, n, TRUE, self$pdf(x))) } else { return(self$quantile(runif(n))) } } ) ) .distr6$decorators <- append(.distr6$decorators, list(FunctionImputation = FunctionImputation))
delta.error.loop <- function(g) { if (g$method=="harmonic2") { z <- g$fit[[1]] rss <- sum(z$residuals^2) p <- z$rank p1 <- 1L:p resvar1 <- rss/z$df.residual R1 <- chol2inv(z$qr$qr[p1, p1, drop = FALSE]) se1 <- sqrt(diag(R1) * resvar1) z2 <- g$fit[[2]] rss <- sum(z2$residuals^2) p <- z2$rank p1 <- 1L:p resvar2 <- rss/z2$df.residual R2 <- chol2inv(z2$qr$qr[p1, p1, drop = FALSE]) se2 <- sqrt(diag(R2) * resvar2) cov.Ta<- R1*resvar1 cov.Tb<- R2*resvar2 cov.matrix <- cbind(rbind(cov.Ta,matrix(0,3,3)),rbind(matrix(0,3,3),cov.Tb)) b.xSE<-deltamethod(~sqrt(x2^2+x3^2),c(z$coefficients,z2$coefficients), cov.matrix) phase.angleSE<-deltamethod(~atan(x3/x2),c(z$coefficients,z2$coefficients), cov.matrix) if (g$values["n"]==1) splitSE <- deltamethod(~atan(x6/sqrt(x2^2+x3^2)),c(z$coefficients,z2$coefficients), cov.matrix)*180/pi else splitSE <- NA hysteresis.ySE <- deltamethod(~x5/x6,c(z$coefficients,z2$coefficients), cov.matrix) m <- g$values["m"] form <- sprintf("~1/sqrt(1+(x6/x5)^(2/%f))",m) hysteresis.xSE<-deltamethod(as.formula(form),c(z$coefficients,z2$coefficients), cov.matrix) coercionform <- sprintf("~sqrt(x2^2+x3^2)/sqrt(1+(x6/x5)^(2/%f))",m) coercionSE<-deltamethod(as.formula(coercionform),c(z$coefficients,z2$coefficients), cov.matrix) lagSE <- deltamethod(~atan(x5/x6),c(z$coefficients,z2$coefficients), cov.matrix)*g$period/(2*pi) leftpart <- (0.5/(beta((m + 3)/2, (m + 3)/2) * (m + 2)) + 1/beta((m + 1)/2, (m + 1)/2) - 1/beta((m + 3)/2, (m - 1)/2))/(2^m) * pi form <- sprintf("~%f * x5* atan(x3/x2)",leftpart) areaSE <- deltamethod(as.formula(form),c(z$coefficients,z2$coefficients), cov.matrix) SEs<- list("n"=NA,"m"=NA,"b.x"=b.xSE,"b.y"=se2[3],"phase.angle"=phase.angleSE, "cx"=se1[1],"cy"=se2[1],"retention"=se2[2],"coercion"=coercionSE,"area"=areaSE,"lag"=lagSE, "split.angle"=splitSE,"hysteresis.x"=hysteresis.xSE,"hysteresis.y"=hysteresis.ySE) } else { n <- length(g$x) coefs <- g$fit$par[(n+1):(n+7)] vmat <- (as.vector(2*crossprod(g$residuals)/(n-7))*solve(g$fit$hessian)) vmat2 <- vmat[(n+1):(n+7),(n+1):(n+7)] SEm <- deltamethod(~exp(x5),coefs,vmat2) SEn <- deltamethod(~exp(x6),coefs,vmat2) coercionSE <- deltamethod(~x3/sqrt(1+(x4/x7)^(2/x5)),coefs,vmat2) hysteresis.xSE <- deltamethod(~1/sqrt(1+(x4/x7)^(2/x5)),coefs,vmat2) areaSE <- NA splitSE <- NA hysteresis.ySE <- deltamethod(~x7/x4,coefs,vmat2) lagSE <- deltamethod(~atan(x7/x4),coefs,vmat2)*g$period/(pi*2) SEs<- list("n"=SEn,"m"=SEm,"b.x"=sqrt(vmat2[3,3]),"b.y"=sqrt(vmat2[4,4]),"phase.angle"=sqrt(vmat[1,1]), "cx"=sqrt(vmat2[1,1]),"cy"=sqrt(vmat2[2,2]),"retention"=sqrt(vmat2[7,7]), "coercion"=coercionSE,"area"=areaSE,"lag"=lagSE, "split.angle"=splitSE,"hysteresis.x"=hysteresis.xSE,"hysteresis.y"=hysteresis.ySE) } SEs }
slice <- function(.data, ..., .preserve = FALSE) { UseMethod("slice") } slice.data.frame <- function(.data, ..., .preserve = FALSE) { loc <- slice_rows(.data, ..., caller_env = caller_env(), error_call = current_env()) dplyr_row_slice(.data, loc, preserve = .preserve) } slice_head <- function(.data, ..., n, prop) { UseMethod("slice_head") } slice_head.data.frame <- function(.data, ..., n, prop) { check_slice_dots(..., n = n, prop = prop) size <- get_slice_size(n = n, prop = prop) idx <- function(n) { to <- size(n) if (to > n) { to <- n } seq2(1, to) } dplyr_local_error_call() slice(.data, idx(dplyr::n())) } slice_tail <- function(.data, ..., n, prop) { UseMethod("slice_tail") } slice_tail.data.frame <- function(.data, ..., n, prop) { check_slice_dots(..., n = n, prop = prop) size <- get_slice_size(n = n, prop = prop) idx <- function(n) { from <- n - size(n) + 1 if (from < 1L) { from <- 1L } seq2(from, n) } dplyr_local_error_call() slice(.data, idx(dplyr::n())) } slice_min <- function(.data, order_by, ..., n, prop, with_ties = TRUE) { UseMethod("slice_min") } slice_min.data.frame <- function(.data, order_by, ..., n, prop, with_ties = TRUE) { check_required(order_by) check_slice_dots(..., n = n, prop = prop) size <- get_slice_size(n = n, prop = prop) if (with_ties) { idx <- function(x, n) head(order(x), smaller_ranks(x, size(n))) } else { idx <- function(x, n) head(order(x), size(n)) } dplyr_local_error_call() slice(.data, local({ order_by <- {{ order_by }} n <- dplyr::n() x <- fix_call(vec_assert(order_by, size = n, arg = "order_by"), NULL) idx(x, n) })) } slice_max <- function(.data, order_by, ..., n, prop, with_ties = TRUE) { UseMethod("slice_max") } slice_max.data.frame <- function(.data, order_by, ..., n, prop, with_ties = TRUE) { check_required(order_by) check_slice_dots(..., n = n, prop = prop) size <- get_slice_size(n = n, prop = prop) if (with_ties) { idx <- function(x, n) head( order(x, decreasing = TRUE), smaller_ranks(desc(x), size(n)) ) } else { idx <- function(x, n) head(order(x, decreasing = TRUE), size(n)) } dplyr_local_error_call() slice(.data, local({ order_by <- {{ order_by }} n <- dplyr::n() order_by <- fix_call(vec_assert(order_by, size = n, arg = "order_by"), NULL) idx(order_by, n) })) } slice_sample <- function(.data, ..., n, prop, weight_by = NULL, replace = FALSE) { UseMethod("slice_sample") } slice_sample.data.frame <- function(.data, ..., n, prop, weight_by = NULL, replace = FALSE) { check_slice_dots(..., n = n, prop = prop) size <- get_slice_size(n = n, prop = prop, allow_negative = FALSE) dplyr_local_error_call() slice(.data, local({ weight_by <- {{ weight_by }} n <- dplyr::n() if (!is.null(weight_by)) { weight_by <- fix_call(vec_assert(weight_by, size = n, arg = "weight_by"), NULL) } sample_int(n, size(n), replace = replace, wt = weight_by) })) } slice_rows <- function(.data, ..., caller_env, error_call = caller_env()) { error_call <- dplyr_error_call(error_call) dots <- enquos(...) if (is_empty(dots)) { return(TRUE) } mask <- DataMask$new(.data, caller_env, "slice", error_call = error_call) on.exit(mask$forget(), add = TRUE) chunks <- slice_eval(mask, dots, error_call = error_call) slice_indices <- slice_combine(chunks, mask = mask, error_call = error_call) vec_c(!!!slice_indices, .ptype = integer()) } is_slice_call <- function(error_call) { is_slice <- TRUE if (is_environment(error_call) && !identical(error_call$.Generic, "slice")) { is_slice <- FALSE } is_slice } slice_eval <- function(mask, dots, error_call = caller_env()) { index <- 0L impl <- function(...) { n <- ...length2() out <- vector("list", n) for (i in seq_len(n)) { index <<- i out[[i]] <- ...elt2(i) } index <<- 0L fix_call( vec_c(!!!out), call = NULL ) } withCallingHandlers( mask$eval_all(quo(impl(!!!dots))), error = function(cnd) { if (index && is_slice_call(error_call)) { local_error_context(dots = dots, .index = index, mask = mask) header <- cnd_bullet_header("evaluating") } else { header <- "Problem while computing indices." } bullets <- c(header, i = cnd_bullet_cur_group_label()) abort(bullets, call = error_call, parent = cnd) } ) } slice_combine <- function(chunks, mask, error_call = caller_env()) { rows <- mask$get_rows() slice_indices <- new_list(length(rows)) withCallingHandlers( for (group in seq_along(rows)) { current_rows <- rows[[group]] res <- chunks[[group]] if (is.logical(res) && all(is.na(res))) { res <- integer() } else if (is.numeric(res)) { if (is.matrix(res) && ncol(res) == 1) { res <- as.vector(res) } res <- fix_call(vec_cast(res, integer()), NULL) } else { bullets <- c( glue("Invalid result of type <{vec_ptype_full(res)}>."), i = "Indices must be positive or negative integers." ) abort(bullets, call = NULL) } if (length(res) == 0L) { } else if (all(res >= 0, na.rm = TRUE)) { res <- res[!is.na(res) & res <= length(current_rows) & res > 0] } else if (all(res <= 0, na.rm = TRUE)) { res <- setdiff(seq_along(current_rows), -res) } else { mask$set_current_group(group) n_positive <- sum(res >= 0, na.rm = TRUE) n_negative <- sum(res <= 0, na.rm = TRUE) bullets <- c( "Indices must be all positive or all negative.", i = glue("Got {n_positive} positives, {n_negative} negatives.") ) abort(bullets, call = NULL) } slice_indices[[group]] <- current_rows[res] }, error = function(cnd) { mask$set_current_group(group) bullets <- c( "Problem while computing indices.", i = cnd_bullet_cur_group_label() ) abort(bullets, call = error_call, parent = cnd) }) slice_indices } check_constant <- function(x, name, error_call = caller_env()) { withCallingHandlers(force(x), error = function(e) { bullets <- c( glue("`{name}` must be a constant.") ) abort(bullets, parent = e, call = error_call) }) } check_slice_dots <- function(..., n, prop, error_call = caller_env()) { if (missing(n) && missing(prop)) { dots <- enquos(...) if (length(dots) == 1L && names2(dots)[1] == "") { slice_call <- error_call$.Generic bullets <- c( "`n` must be explicitly named.", i = glue("Did you mean `{slice_call}(n = {as_label(dots[[1]])})`?") ) abort(bullets, call = error_call) } } check_dots_empty(call = error_call) } check_slice_n_prop <- function(n, prop, error_call = caller_env()) { if (missing(n) && missing(prop)) { list(type = "n", n = 1L) } else if (!missing(n) && missing(prop)) { n <- check_constant(n, "n", error_call = error_call) if (!is.numeric(n) || length(n) != 1 || is.na(n)) { abort("`n` must be a single number.", call = error_call) } list(type = "n", n = n) } else if (!missing(prop) && missing(n)) { prop <- check_constant(prop, "prop", error_call = error_call) if (!is.numeric(prop) || length(prop) != 1 || is.na(prop)) { abort("`prop` must be a single number.", call = error_call) } list(type = "prop", prop = prop) } else { abort("Must supply `n` or `prop`, but not both.", call = error_call) } } get_slice_size <- function(n, prop, allow_negative = TRUE, error_call = caller_env()) { slice_input <- check_slice_n_prop(n, prop, error_call = error_call) if (slice_input$type == "n") { if (slice_input$n > 0) { function(n) floor(slice_input$n) } else if (allow_negative) { function(n) ceiling(n + slice_input$n) } else { abort("`n` must be positive.", call = error_call) } } else if (slice_input$type == "prop") { if (slice_input$prop > 0) { function(n) floor(slice_input$prop * n) } else if (allow_negative) { function(n) ceiling(n + slice_input$prop * n) } else { abort("`prop` must be positive.", call = error_call) } } } sample_int <- function(n, size, replace = FALSE, wt = NULL) { if (size == 0L) { integer(0) } else { sample.int(n, size, prob = wt, replace = replace) } } smaller_ranks <- function(x, y) { sum(min_rank(x) <= y, na.rm = TRUE) }
"Baz"
KHQ5D <- function( scores, country, type, author, year, source, ignore.invalid = FALSE, weights = NULL, save.xlsx = FALSE, filename = NULL, sheetName = NULL ){ DimensionNames <- c("RL", "PL", "SL", "E", "S") if (is.numeric(scores) & length(names(scores)) == 5) { if (!all(DimensionNames %in% names(scores))) { print(names(scores)) stop("Unable to identify KHQ5D dimensions (RL, PL, SL, E, and S) in data.") } } else if (is.data.frame(scores) & length(names(scores)) == 5) { if (!all(DimensionNames %in% names(scores))) { print(names(scores)) stop("Unable to identify KHQ5D dimensions (RL, PL, SL, E, and S) in data.") } } if (length(as.data.frame(scores)) == 1 & length(names(scores)) != 5) { scores <- data.frame(score = scores) colnames(scores) <- "score" scores <- strsplit(as.character(scores$score), "") if (!all(lengths(scores) == 5)) { digitMissing <- data.frame(digitMissing = lengths(scores) != 5, numDigit = lengths(scores)) digitMissing$rowDigitMissing <- rownames(digitMissing) print(digitMissing[digitMissing[,1] == "TRUE", 2:3]) stop("Unable to identify the five digit format in the data.") } scores <- do.call(rbind, scores) %>% data.frame() colnames(scores) <- DimensionNames } else if (is.numeric(scores)) { scores <- as.data.frame(matrix(scores, ncol = 5)) colnames(scores) <- DimensionNames } if (ignore.invalid == FALSE & any(is.na(scores) == TRUE)){ rowNAs = which(is.na(scores) == TRUE, arr.ind = TRUE) %>% data.frame() print(scores[unique(rowNAs$row),]) stop("Missing/non-numeric dimension found. In case the response was randomly lost, consider use ignore.invalid == TRUE to avoid further problems.") } if (any(apply(scores, 1, function(x) !all(x %in% c(NA,1:4))) == TRUE)) { rowCodedWrong <- data.frame(rowCodedWrong = apply(scores, 1, function(x) !all(x %in% c(NA,1:4)))) rowCodedWrong <- data.frame(rowCodedWrong = rowCodedWrong, numRowCodeWrong = rownames(rowCodedWrong)) print(scores[rowCodedWrong[rowCodedWrong[,1] == "TRUE", 2],]) stop("Scores must be coded as 1, 2, 3 or 4 for KHQ5D.") } Utility_Index_data <- KHQ::Utility_Index_data if (!any(country == unique(colnames(Utility_Index_data)[-1]))) { print(data.frame(Country = unique(unique(colnames(Utility_Index_data)[-1])))) stop("Country must be one of the above.") } Utility_Index_data <- Utility_Index_data[, c(1, grep(pattern = paste0("^", country), colnames(Utility_Index_data)))] info_data <- Utility_Index_data[(which(Utility_Index_data$Variables == "Year" | Utility_Index_data$Variables == "Author" | Utility_Index_data$Variables == "Type" | Utility_Index_data$Variables == "Source")), ] collist <- colnames(info_data) select_score <- apply(info_data[,collist], 2, function(x) all(x %in% c(year, author, type, source))) if (select_score[-1] == FALSE) { colnames(info_data) <- NULL rownames(info_data) <- NULL print(info_data) stop("\n Information set type not recognized.\n Year, Author, Type, and Source must be one of the above.") } Utility_Index_data <- data.frame(Variables = Utility_Index_data$Variables, data_country = Utility_Index_data[,select_score]) df_Sco_Uti_Ind <- Utility_Index_data[-(which(Utility_Index_data$Variables == "Year" | Utility_Index_data$Variables == "Author" | Utility_Index_data$Variables == "Type" | Utility_Index_data$Variables == "Source" | Utility_Index_data$Variables == "Health state")), ] df_Sco_Uti_Ind$data_country <- as.numeric(df_Sco_Uti_Ind$data_country) df_Sco_Uti_Ind <- data.frame(RL = c(0, df_Sco_Uti_Ind[2:4,2]), PL = c(0, df_Sco_Uti_Ind[5:7,2]), SL = c(0, df_Sco_Uti_Ind[8:10,2]), E = c(0, df_Sco_Uti_Ind[11:13,2]), S = c(0, df_Sco_Uti_Ind[14:16,2])) df_weight <- data.frame(matrix(0, nrow = nrow(scores), ncol = ncol(scores))) colnames(df_weight) <- DimensionNames for (i in 1:nrow(scores)) { if (is.na(scores[i,1])) { df_weight[i,1] <- NA } else { df_weight[i,1] <- df_Sco_Uti_Ind[scores[i,1],1] } if (is.na(scores[i,2])) { df_weight[i,2] <- NA } else { df_weight[i,2] <- df_Sco_Uti_Ind[scores[i,2],2] } if (is.na(scores[i,3])) { df_weight[i,3] <- NA } else { df_weight[i,3] <- df_Sco_Uti_Ind[scores[i,3],3] } if (is.na(scores[i,4])) { df_weight[i,4] <- NA } else { df_weight[i,4] <- df_Sco_Uti_Ind[scores[i,4],4] } if (is.na(scores[i,5])) { df_weight[i,5] <- NA } else { df_weight[i,5] <- df_Sco_Uti_Ind[scores[i,5],5] } } FullHealth <- Utility_Index_data[which(Utility_Index_data$Variables == "FullHealth"),2] %>% as.numeric() df_Uti_Ind <- data.frame(UtilityIndex = 1:nrow(scores)) for (i in 1:nrow(scores)) { df_Uti_Ind[i,] <- FullHealth - abs(sum(df_weight[i,])) } if (!is.null(weights)) {df_Uti_Ind <- cbind(df_weight, df_Uti_Ind)} if (!is.null(weights) & save.xlsx == TRUE & is.null(filename) & is.null(sheetName)) { openxlsx::write.xlsx(df_Uti_Ind, file = "Res_KHQ5D_weig_uti_ind.xlsx", sheetName = "Weights_Utility_Index", keepNA = FALSE, na.string = "NA", overwrite = TRUE) } else if (save.xlsx == TRUE & is.null(filename) & is.null(sheetName)) { openxlsx::write.xlsx(df_Uti_Ind, file = "Res_KHQ5D_uti_ind.xlsx", sheetName = "Utility_Index", keepNA = FALSE, na.string = "NA", overwrite = TRUE) } else if (save.xlsx == TRUE) { openxlsx::write.xlsx(df_Uti_Ind, file = filename, sheetName = sheetName, keepNA = FALSE, na.string = "NA", overwrite = TRUE) } return(df_Uti_Ind) }
NULL fixed <- function(xname, method=c("z", "t", "f", "chisq", "anova", "lr", "sa", "kr", "pb")) { method <- if(missing(method)) "default" else match.arg(method) test <- switch(method, default = defaulttest, z = ztest, t = ttest, f = waldftest, lr = lrtest, chisq = waldchisqtest, anova = anovatest, kr = krtest, sa = satest, pb = pbtest ) descriptionText <- switch(method, default = "default", z = "z-test", t = "t-test", f = paste0("Type-",getSimrOption("carTestType"), " F-test (package car)"), lr = "Likelihood ratio", chisq = paste0("Type-",getSimrOption("carTestType"), " Chi-Square-test (package car)"), anova = "F-test", kr = "Kenward Roger (package pbkrtest)", sa = "Satterthwait (package lmerTest)", pb = "Parametric bootstrap (package pbkrtest)" ) description <- fixeddesc(descriptionText, xname) rval <- function(.) test(., xname) wrapTest(rval, str_c("for predictor '", removeSquiggle(xname), "'"), description) } fixeddesc <- function(text, xname) { function(fit, sim) { if(text %in% c("t-test") & inherits(fit,"merMod")){ text <- paste(text,"with",getSimrOption("lmerTestDdf"), "degrees of freedom (package lmerTest)") }else if(text %in% c("F-test")){ if(inherits(fit,"merMod")){ text <- paste0("Type-", getSimrOption("lmerTestType")," ", text, " with ",getSimrOption("lmerTestDdf")," degrees of freedom (package lmerTest)") }else{ text <- paste("Type-I",text) } } rval <- if(text=="default") defaultdesc(fit, xname) else text fe <- maybe(fixef)(sim)$value if(!is.null(fe) && xname %in% names(fe)) { rval[2] <- sprintf("Effect size for %s is % } return(rval) } } defaulttest <- function(fit, xname) { x <- getData(fit)[[xname]] if(is.factor(x) || is.character(x)) { return(lrtest(fit, xname)) } switch(class(fit)[1], lm = ttest(fit, xname), glm = ztest(fit, xname), lmerMod = krtest(fit, xname), glmerMod = ztest(fit, xname), stop(str_c("No default test for ", class(fit)[1])) ) } checkInteractions <- function(fit, xname) { ts <- terms(fit) order <- attr(ts, "order") label <- attr(ts, "term.labels") xname %in% unlist(str_split(label[order > 1], stringr::fixed(":"))) } defaultdesc <- function(fit, xname) { if(is.factor(getData(fit)[[xname]])) return("Likelihood ratio") switch(class(fit)[1], lm = "t-test", glm = "z-test", lmerMod = "Kenward Roger (package pbkrtest)", glmerMod = "z-test", "unknown test" ) } compare <- function(model, method=c("lr", "pb")) { method <- match.arg(method) test <- switch(method, lr = lrcompare, pb = pbcompare ) description <- switch(method, lr = "Likelihood ratio", pb = "Parametric bootstrap (package pbkrtest)" ) rval <- function(fit1) { fit2 <- update(fit1, formula(model), evaluate=FALSE) fit2 <- eval(fit2, envir=environment(formula(fit1))) test(fit1, fit2) } description[2] <- str_c("Comparison to ", deparse(formula(model))) wrapTest(rval, "for model comparison", description) } fcompare <- function(model, method=c("lr", "kr", "pb")) { method <- match.arg(method) test <- switch(method, lr = lrcompare, kr = krcompare, pb = pbcompare ) description <- switch(method, lr = "Likelihood ratio", kr = "Kenward-Roger (package pbkrtest)", pb = "Parametric bootstrap (package pbkrtest)" ) rval <- function(fit1) { fe.part <- deparse(nobars(formula(model))) re.part <- do.call(str_c, c(llply(findbars(formula(fit1)), function(.) str_c("(", deparse(.), ")")), sep=" + ")) new.formula <- str_c(fe.part, " + ", re.part) fit2 <- update(fit1, as.formula(new.formula), evaluate=FALSE) fit2 <- eval(fit2, envir=environment(formula(fit1))) test(fit1, fit2) } description[2] <- str_c("Comparison to ", deparse(formula(model)), " + [re]") wrapTest(rval, "for model comparison", description) } rcompare <- function(model, method=c("lr", "pb")) { method <- match.arg(method) test <- switch(method, lr = lrcompare, pb = pbcompare ) description <- switch(method, lr = "Likelihood ratio", pb = "Parametric bootstrap (package pbkrtest)" ) rval <- function(fit1) { fe.part <- deparse(nobars(formula(fit1))) re.part <- laply(findbars(formula(model)), function(.) str_c("(", deparse(.), ")")) new.formula <- str_c(fe.part, " + ", re.part) fit2 <- update(fit1, as.formula(new.formula), evaluate=FALSE) fit2 <- eval(fit2, envir=environment(formula(fit1))) test(fit1, fit2) } description[2] <- str_c("Comparison to [fe] + ", deparse(formula(model))) wrapTest(rval, "for model comparison", description) } random <- function() { rval <- function(.) exactRLRT(.)$p.value rval <- wrapTest(rval, "for a single random effect", "Exact restricted LRT (package RLRsim)") return(rval) } wrapTest <- function(test, text="[user defined]", description="[user defined function]") { if(is.character(text)) { this.text <- str_c("Power ", text) text <- function(...) this.text } if(is.character(description)) { this.description <- description description <- function(...) this.description } if(is.null(attr(test, "text"))) attr(test, "text") <- text if(is.null(attr(test, "description"))) attr(test, "description") <- description return(test) } addSquiggle <- function(x) { if(inherits(x, "formula")) return(x) if(inherits(x, "character")) { return(formula(str_c("~", x))) } stop(str_c("Can't interpret a fixed effect name with class ", class(x)[[1]])) } removeSquiggle <- function(x) { if(inherits(x, "character")) return(x) if(inherits(x, "formula")) { return(deparse(x[[length(x)]])) } stop(str_c("Can't interpret a fixed effect name with class ", class(x)[[1]])) } ztest <- function(fit, xname) { xname <- removeSquiggle(xname) if(is_lmerTest(fit)) { a <- lmerTest_summary(fit, ddf="lme4")$coefficients } else { a <- summary(fit)$coefficients } if(inherits(fit, "lmerMod")) { rval <- pnorm(abs(a[xname, "t value"]), lower.tail=FALSE)*2 } else { rval <- a[xname, "Pr(>|z|)"] } return(rval) } ttest <- function(fit, xname) { xname <- removeSquiggle(xname) if(inherits(fit, "merMod")){ if(requireNamespace("lmerTest", quietly=TRUE)) { a <- lmerTest_summary(fit, ddf=getSimrOption("lmerTestDdf"))$coefficients } else { stop("t-tests for lmer models require the lmerTest package") } } else { a <- summary(fit)$coefficients } rval <- a[xname, "Pr(>|t|)"] return(rval) } waldftest <- function(fit, xname) { if(checkInteractions(fit, xname)) warning("Main effect (", xname, ") was tested but there were interactions.") xname <- removeSquiggle(xname) if(inherits(fit, "merMod") & !isREML(fit)) { warning("F test available only for linear mixed model fit by REML: refitting model with REML.") fit <- update(fit, REML=TRUE) } a <- Anova(fit,test.statistic="F", type=getSimrOption("carTestType")) rval <- a[xname, "Pr(>F)"] return(rval) } waldchisqtest <- function(fit, xname) { if(checkInteractions(fit, xname)) warning("Main effect (", xname, ") was tested but there were interactions.") xname <- removeSquiggle(xname) a <- Anova(fit, test.statistic="Chisq", type=getSimrOption("carTestType")) rval <- a[xname, "Pr(>Chisq)"] return(rval) } anovatest <- function(fit, xname){ if(checkInteractions(fit, xname)) warning("Main effect (", xname, ") was tested but there were interactions.") xname <- removeSquiggle(xname) if(inherits(fit,"merMod")) { if(is_lmerTest(fit)) { a <- lmerTest_anova(fit, ddf=getSimrOption("lmerTestDdf"), type=getSimrOption("lmerTestType")) } else { if(requireNamespace("lmerTest", quietly=TRUE)) { a <- lmerTest_anova(fit, ddf=getSimrOption("lmerTestDdf"), type=getSimrOption("lmerTestType")) } else { stop("anova-tests for lmer-fitted models require the lmerTest package") } } } else { a <- anova(fit) } rval <- a[xname, "Pr(>F)"] return(rval) } lrtest <- function(fit, xname) { if(checkInteractions(fit, xname)) warning("Main effect (", xname, ") was tested but there were interactions.") dropname <- addSquiggle(xname) xname <- removeSquiggle(xname) test <- if(inherits(fit, "lm") && family(fit)$family == "gaussian") "F" else "Chisq" a <- drop1(fit, dropname, test=test) testname <- grep("Pr\\(", colnames(a), value=TRUE) rval <- a[xname, testname] return(rval) } drop1test <- function(fit, xname, fun, ...) { dropname <- addSquiggle(xname) xname <- removeSquiggle(xname) a <- drop1(fit, dropname, test="user", sumFun=fun, ...) rval <- a[xname, "p.value"] return(rval) } krWrap <- function(object, objectDrop, ...) { krnames <- c("ndf", "ddf", "Fstat", "p.value", "F.scaling") if(missing(objectDrop)) return(setNames(rep(NA, length(krnames)), krnames)) krtest <- suppressMessages(KRmodcomp(object, objectDrop)) rval <- unlist(krtest$stats[krnames]) return(rval) } krtest <- function(fit, xname) { if(checkInteractions(fit, xname)) warning("Main effect (", xname, ") was tested but there were interactions.") drop1test(fit, xname, krWrap) } pbWrap <- function(object, objectDrop, ...) { pbnames <- c("stat", "df", "p.value") if(missing(objectDrop)) return(setNames(rep(NA, length(pbnames)), pbnames)) pbtest <- PBmodcomp(object, objectDrop, nsim=getSimrOption("pbnsim")) rval <- unlist(pbtest$test["PBtest", pbnames]) return(rval) } pbtest <- function(fit, xname) drop1test(fit, xname, pbWrap) satest <- function(fit, xname) { xname <- removeSquiggle(xname) a <- lmerTest_summary(fit, ddf="Satterthwaite")$coefficients rval <- a[xname, "Pr(>|t|)"] return(rval) } krcompare <- function(model1, model2) { suppressMessages(KRmodcomp(model1, model2)$stats$p.value) } pbcompare <- function(model1, model2) { PBmodcomp(model1, model2, nsim=getSimrOption("pbnsim"))$test["PBtest", "p.value"] } lrcompare <- function(model1, model2) { suppressMessages(anova(model1, model2, test="Chisq")$Pr[2]) }
ladfit = function (x, y, intercept = TRUE) { tolerance = 1e-07 print.it = TRUE xn = if (is.matrix(x)) dimnames(x)[[2]] else "X" x = as.matrix(x) dx = dim(x) vars = dx[2] if (length(xn) == 0) xn = paste("X", 1:vars, sep = "") if (intercept) { vars = vars + 1 xn = c("Intercept", xn) x = cbind(1, x) } obs = dx[1] if (obs != length(y)) stop("Y and X have different number of observations!") if (obs <= vars) stop("Less observations than variables") storage.mode(y) <- "double" z <- matrix(0, nrow = obs + 2, ncol = vars + 2) z[1:obs, 1:vars] <- x storage.mode(z) <- "double" fit <- .Fortran("l1", n = as.integer(obs), p = as.integer(vars), n2 = as.integer(obs + 2), p2 = as.integer(vars + 2), z = z, y = y, tol = as.double(tolerance), cf = double(vars), resid = double(obs), work = integer(obs)) minimum <- fit$z[obs + 1, vars + 1] rank = fit$z[obs + 1, vars + 2] info = fit$z[obs + 2, vars + 1] numIter = fit$z[obs + 2, vars + 2] fitted = drop(x %*% fit$cf) msg = character(0) if (info == 0) { msg = "Non-unique solution possible!" if (print.it) warning(msg) } else if (info != 1) stop("Premature termination!!") if (rank != vars) { msg = c(msg, paste("Matrix not of full rank, apparent rank", rank)) if (print.it) warning(msg[length(msg)]) } out = list(coefficients = fit$cf, minimum = minimum, fitted.values = fitted, residuals = fit$resid, rank = rank, numIter = numIter, info = info) names(out$coefficients) <- xn if (length(msg)) out$message = list(msg) out }
hclust.grouping <- function(current.peaks, min.samp.grp = 1, max.dupli.prop = 0.25, maxClust = 10, linkage = "average") { if (nrow(current.peaks) <= 1) { regrouped.peaks <- current.peaks } else { if (nrow(current.peaks) < maxClust) { maxClust <- nrow(current.peaks) - 1 } dissE <- cluster::daisy(matrix(c(current.peaks$peakPPM), ncol = 1), metric = "euclid", stand = TRUE, warnType = FALSE) fit <- stats::hclust(dissE, method = linkage) duplicates <- numeric(maxClust) duplicates[1] <- sum(duplicated(current.peaks$Sample)) groupassignment <- matrix(NA, ncol = maxClust + 1, nrow = length(current.peaks$Sample)) grpcounter <- 1 if (sum(duplicated(current.peaks$Sample))/length(current.peaks$Sample) < max.dupli.prop) { groupassignment[, 1] <- grpcounter grpcounter <- grpcounter + 1 } for (k in 2:maxClust) { groups <- stats::cutree(fit, k) dup.sub.prop <- numeric(k) sub.size <- numeric(k) for (kk in 1:k) { dup.sub.prop[kk] <- sum(duplicated(current.peaks$Sample[groups == kk]))/length(current.peaks$Sample[groups == kk]) sub.size[kk] <- length(current.peaks$Sample[groups == kk]) if (dup.sub.prop[kk] <= max.dupli.prop & sub.size[kk] >= min.samp.grp) { groupassignment[groups == kk, k] <- grpcounter grpcounter <- grpcounter + 1 } } duplicates[k] <- mean(dup.sub.prop) } for (s in seq_along(current.peaks$Sample)) { groupassignment[s, maxClust + 1] <- suppressWarnings(min(groupassignment[s, 1:maxClust], na.rm = TRUE)) } group <- rep(0, length(current.peaks$Sample)) grps <- unique(groupassignment[, maxClust + 1]) grps <- grps[!is.infinite(grps)] if (length(grps) > 0) { for (cl in seq_along(grps)) { group[groupassignment[, maxClust + 1] == grps[cl]] <- cl } ngrps <- max(group) starts <- numeric(ngrps) stops <- numeric(ngrps) for (g in 1:ngrps) { starts[g] <- min(current.peaks$peakPPM[group == g]) stops[g] <- max(current.peaks$peakPPM[group == g]) } for (gg in 1:ngrps) { if (any(duplicated(current.peaks$Sample[group == gg]))) { duplicated.samples <- unique(current.peaks$Sample[group == gg][duplicated(current.peaks$Sample[group == gg])]) group.meanppm <- mean(current.peaks$peakPPM[group == gg][!current.peaks$Sample[group == gg] %in% duplicated.samples]) group.meanSNR <- mean(current.peaks$peakSNR[group == gg][!current.peaks$Sample[group == gg] %in% duplicated.samples]) for (ds in seq_along(duplicated.samples)) { dat.mat <- matrix(c(group.meanppm, current.peaks$peakPPM[group == gg & current.peaks$Sample == duplicated.samples[ds]], group.meanSNR, current.peaks$peakSNR[group == gg & current.peaks$Sample == duplicated.samples[ds]]), ncol = 2, byrow = F) nduplis <- nrow(dat.mat) - 1 peak.to.keep <- which.min(cluster::daisy(dat.mat, metric = "gower", stand = FALSE)[1:nduplis]) to.remove <- seq(1, nduplis) to.remove <- to.remove[-peak.to.keep] group[group == gg & current.peaks$Sample == duplicated.samples[ds]][to.remove] <- rep(0, length(to.remove)) } } } group.order <- order(starts) stops <- stops[group.order] starts <- starts[group.order] if (any((starts[2:ngrps] - stops[1:ngrps - 1]) < 0)) { overlapping.groups <- which((starts[2:ngrps] - stops[1:ngrps - 1]) < 0) all.overlapping.groups <- matrix(c(overlapping.groups, overlapping.groups + 1), ncol = 2) for (jj in seq(from = nrow(all.overlapping.groups), to = 1, by = -1)) { group[group == all.overlapping.groups[jj, 2]] <- all.overlapping.groups[jj, 1] } ngrps <- ngrps - nrow(all.overlapping.groups) if (any(!(seq(1, ngrps) %in% group))) { curr.grps <- sort(unique(group[group > 0])) for (gg in seq_along(curr.grps)) { group[group == curr.grps[gg]] <- gg } } } regrouped.peaks <- current.peaks[group > 0, , drop = FALSE] group <- group[group > 0, drop = FALSE] if (nrow(regrouped.peaks) > 0) { for (g in 1:max(group)) { theoretical.centerIndex <- round(as.numeric(stats::kmeans(regrouped.peaks$peakIndex[group == g], centers = 1)[2])) regrouped.peaks$peakIndex[group == g] <- theoretical.centerIndex } regrouped.peaks <- regrouped.peaks[order(regrouped.peaks$peakIndex), ] } } else { regrouped.peaks <- matrix(NA, ncol = 6, nrow = 0) } } return(regrouped.peaks) }
bn.boot = function(data, statistic, R = 200, m = nrow(data), algorithm, algorithm.args = list(), statistic.args = list(), cluster, debug = FALSE) { check.data(data) R = check.replicates(R) m = check.bootsize(m, data) check.logical(debug) check.learning.algorithm(algorithm) algorithm.args = check.learning.algorithm.args(algorithm.args) statistic = match.fun(statistic) if (isTRUE(all.equal(statistic, base::I))) statistic = function(x) x if (!is.list(statistic.args)) statistic.args = as.list(statistic.args) cluster = check.cluster(cluster) if (!is.null(cluster)) { if (debug) { warning("disabling debugging output for parallel computing.") debug = FALSE } } bootstrap.backend(data = data, statistic = statistic, R = R, m = m, algorithm = algorithm, algorithm.args = algorithm.args, statistic.args = statistic.args, cluster = cluster, debug = debug) } boot.strength = function(data, cluster, R = 200, m = nrow(data), algorithm, algorithm.args = list(), cpdag = TRUE, debug = FALSE) { data.info = check.data(data) nodes = names(data) R = check.replicates(R) m = check.bootsize(m, data) check.logical(debug) check.logical(cpdag) check.learning.algorithm(algorithm) algorithm.args = check.learning.algorithm.args(algorithm.args) cluster = check.cluster(cluster) if (!is.null(cluster)) { slaves.setup(cluster) if (debug) { warning("disabling debugging output for parallel computing.") debug = FALSE } } res = arc.strength.boot(data = data, cluster = cluster, R = R, m = m, algorithm = algorithm, algorithm.args = algorithm.args, arcs = NULL, cpdag = cpdag, debug = debug) res = structure(res, nodes = nodes, method = "bootstrap", threshold = threshold(res), class = c("bn.strength", class(res))) if (data.info$type == "mixed-cg") attr(res, "illegal") = list.cg.illegal.arcs(names(data), data) return(res) } bn.cv = function(data, bn, loss = NULL, ..., algorithm.args = list(), loss.args = list(), fit = "mle", fit.args = list(), method = "k-fold", cluster, debug = FALSE) { data.info = check.data(data) nodes = names(data) method = check.cv.method(method) extra.args = check.cv.args(method, list(...), data) check.fitting.method(fit, data) cluster = check.cluster(cluster) if (!is.null(cluster)) { if (debug) { warning("disabling debugging output for parallel computing.") debug = FALSE } } if (is.character(bn)) { check.learning.algorithm(bn) loss = check.loss(loss, data, bn) algorithm.args = check.learning.algorithm.args(algorithm.args) if ((loss %in% c("pred", "pred-exact", "pred-lw")) && (is.null(loss.args$target)) && (bn %in% classifiers)) loss.args$target = algorithm.args$training loss.args = check.loss.args(loss, bn, nodes, data, loss.args) } else if (is(bn, "bn")) { if (!identical(algorithm.args, list())) warning("no learning algorithm is used, so 'algorithm.args' will be ignored.") check.bn.vs.data(bn, data) loss = check.loss(loss, data, bn) if (!is.dag(arcs = bn$arcs, nodes = nodes)) { if (!is.null(bn$learning$undirected) && bn$learning$undirected) warning(deparse(substitute(bn)), " is just a skeleton (no arc directions ", "have been learned) and trying to extend it is probably wrong.") bn = cpdag.extension(cpdag.backend(bn, moral = TRUE, wlbl = TRUE)) if (!is.dag(arcs = bn$arcs, nodes = nodes)) stop("the network from the 'bn' argument has no consistent extension.") } if (is(bn, "bn.naive")) check.bn.naive(bn) loss.args = check.loss.args(loss, bn, nodes, data, loss.args) } else { stop("'bn' must be either the label of a learning algorithm or a bn object.") } actual.runs = ifelse(is.null(extra.args$runs), 1, extra.args$runs) result = structure(vector(actual.runs, mode = "list"), class = "bn.kcv.list") for (r in seq(actual.runs)) result[[r]] = crossvalidation(data = data, bn = bn, loss = loss, k = extra.args$k, m = extra.args$m, folds = extra.args$folds[[r]], algorithm.args = algorithm.args, loss.args = loss.args, fit = fit, fit.args = fit.args, method = method, cluster = cluster, data.info = data.info, debug = debug) if (actual.runs == 1) return(result[[1]]) else return(result) } loss = function(x) { if (is(x, "bn.kcv")) losses = attr(x, "mean") else if (is(x, "bn.kcv.list")) losses = sapply(x, function(x) attr(x, "mean")) else stop("x must be an object of class 'bn.kcv' or 'bn.kcv.list'.") return(losses) }
PlotEmpiricalOperatingCharacteristics <- function(dataset, trts = 1, rdrs = 1, opChType, legend.position = c(0.8, 0.3), maxDiscrete = 10) { if (dataset$descriptions$type == "ROI") stop("No operating characteristics are defined for an ROI dataset") if (opChType == "ROC"){ if (dataset$descriptions$type == "FROC") ds <- DfFroc2Roc(dataset) else if (dataset$descriptions$type == "LROC") ds <- DfLroc2Roc(dataset) else ds <- dataset } else if ((opChType %in% c("FROC", "AFROC", "wAFROC", "AFROC1", "wAFROC1")) && (dataset$descriptions$type == "FROC")) { ds <- dataset } else if ((opChType == "LROC") && (dataset$descriptions$type == "LROC")) { ds <- dataset } else { errMsg <- sprintf("%s is not a valid operating characteristic for this dataset", opChType) stop(errMsg) } ret <- gpfPlotGenericEmpiricalOperatingCharacteristic(ds, trts, rdrs, opChType = opChType, legend.position, maxDiscrete) return(ret) }
prediction.hetglm <- function(model, data = find_data(model, parent.frame()), at = NULL, type = c("response", "link", "scale"), calculate_se = FALSE, ...) { type <- match.arg(type) data <- data if (missing(data) || is.null(data)) { pred <- make_data_frame(fitted = predict(model, type = type, ...)) } else { if (is.null(at)) { out <- data } else { out <- build_datalist(data, at = at, as.data.frame = TRUE) at_specification <- attr(out, "at_specification") } tmp <- predict(model, newdata = out, type = type, ...) pred <- make_data_frame(out, fitted = tmp, se.fitted = rep(NA_real_, length(tmp))) } vc <- NA_real_ structure(pred, class = c("prediction", "data.frame"), at = if (is.null(at)) at else at_specification, type = type, call = if ("call" %in% names(model)) model[["call"]] else NULL, model_class = class(model), row.names = seq_len(nrow(pred)), vcov = vc, jacobian = NULL, weighted = FALSE) }
print.fmanovatrp = function(x, ...){ cat("\n", "FMANOVA - Tests based on Random Projections", "\n") iik = 0 for(ik in x$k){ iik = iik + 1 cat("\n", "Number of random projections k =", ik, "\n") cat("p-value Wilks =", (x$pvalues)[1, iik], "\n") cat("p-value Lawley-Hotelling =", (x$pvalues)[2, iik], "\n") cat("p-value Pillai =", (x$pvalues)[3, iik], "\n") cat("p-value Roy =", (x$pvalues)[4, iik], "\n") } }
library(testthat) library(callr) if (Sys.getenv("NOT_CRAN", "") == "true") test_check("callr")
freeVariables = undefinedVariables = function(sc, info = as(sc, "ScriptInfo")) { pos = seq(from = 1, to = length(info)) outputs = lapply(info[ - length(pos) ], function(x) x@outputs) ans = character() defs = character() for(i in pos) { el = info[[i]] ans = c(ans, setdiff(el@inputs, defs)) defs = c(defs, el@outputs) } ans } unusedVariables = function(sc, info = as(sc, "ScriptInfo")) { pos = seq(from = 1, to = length(info) - 1L) inputs = lapply(info[pos + 1], function(x) x@inputs) ans = character() for(i in pos) { el = info[[i]] ans = c(ans, setdiff(el@outputs, unlist(inputs)[i:length(pos)])) } ans }
tabItem(tabName = "hedging", fluidRow( column(12, h3("Here you can manage the risk of a portfolio composed of options and the underlying asset.",class = "hTitle"), h4("The evolution of the underlying asset is simulated by the models you estimated in the Modeling section.", br(), "After performing the simulation, click on the Show P&L button in the Profit&Loss tab and customize your portfolio.",br(), "The Profit&Loss distribution of your portfolio will be displayed (it includes transaction costs that you can customize)."), hr(class = "hrHeader") ) ), fluidRow(column(12,bsAlert("hedging_alert"))), tabsetPanel(id = "panel_hedging", type = "tabs", tabPanel(title = "Start simulations", fluidRow(column(12, br(), h4("Click on the model in order to simulate the evolution of the underlying asset"), DT::dataTableOutput("hedging_databaseModels") ) ), br(), fluidRow(column(12,div(align="center", br(), fluidRow( column(3,selectInput("hedging_type", label="Option Type:", c(Call="call", Put="put"))), column(3,uiOutput("hedging_strike")), column(3,dateInput("hedging_maturity", label="Maturity:", value = Sys.Date()+30)), column(3,numericInput("hedging_optMarketPrice", label="Option Market Price:", value=NA, min = 0)) ), fluidRow( column(3), column(3,uiOutput("hedging_assMarketPrice")), column(3,numericInput("hedging_lotMult", label="Number of Options per Lot:", value=1, min = 1)), column(3) ), fluidRow( column(4), column(4,numericInput("hedging_nSim", label="Number of Simulations", value=1000, min = 1)), column(4) ), fluidRow( column(4), column(4, actionButton("hedging_button_startComputation", label = "Start Computation", width = "50%")) ) ))) ), tabPanel(title = "Profit&Loss", bsModal(id="hedging_commissionPlan", trigger = "hedging_button_show", title = "Profit & Loss", size = "large", div(id="hedging_body",align="center", fluidRow( column(3), column(6, uiOutput("hedging_modal_id")), column(3, uiOutput("hedging_modal_id_hidden")) ), fluidRow( column(3), column(3,uiOutput("hedging_nOptLot_hedge")), column(3,uiOutput("hedging_nAss_hedge")) ), fluidRow( column(9, plotOutput("hedging_plot_distribution")), column(3, sliderInput("hedging_slider_nBin", label = "Adjust bin width", min=1, max=100, value = 30, step = 1, ticks = FALSE), br(), sliderInput("hedging_slider_rangeHist", label = "Quantiles (%)", min = 0, max = 100, value = c(5,95), ticks = FALSE, step = 0.01), uiOutput("hedging_quantiles_text"), br(),br(), uiOutput("hedging_capital_text"), br(),br(), actionButton("hedging_button_saveHedging", "Save Changes", width = "80%") ) ), br(), box(title = p("Modify Option", style="color:black; font-weight: bold;"),collapsible = TRUE, collapsed = FALSE, width = 12, fluidRow( column(4,uiOutput("hedging_type2")), column(4,uiOutput("hedging_strike2")), column(4,uiOutput("hedging_optMarketPrice2")) ) ), box(title = p("Trading Costs", style="color:black; font-weight: bold;"),collapsible = TRUE, collapsed = FALSE, width = 12, fluidRow( column(3,br(),numericInput("hedging_percCostAss", label="Asset: Trading cost (%):", value=0.19, min = 0)), column(3,br(),numericInput("hedging_minCostAss", label="Asset: Min trading cost:", value=2.95, min = 0)), column(3,numericInput("hedging_rateShort", label="Asset: Yearly interest rate short position (%):", value=4.95, min = 0)), column(3,numericInput("hedging_lotCostOpt", label="Option: Trading cost per lot:", value=5.95, min = 0)) ) ) ) ), fluidRow(column(12,br(), DT::dataTableOutput("hedging_table_results") )), br(), fluidRow( column(2,actionButton(inputId = "hedging_button_show", label = "Show P&L")), column(6), column(2,actionButton(inputId = "hedging_button_delete", label = "Delete")), column(2,actionButton(inputId = "hedging_button_deleteAll", label = "Delete All")) ) ) ) )
"binAC" <- function(n, y, conf.level=0.95, alternative="two.sided") { alpha=1-conf.level est=y/n z1s=qnorm(conf.level) z2s=qnorm(1-alpha/2) esti1s=(y+(z1s^2)/2)/(n+z1s^2) esti2s=(y+(z2s^2)/2)/(n+z2s^2) ni1s=n+z1s^2 ni2s=n+z2s^2 if(alternative=="two.sided"){ CI=c(esti2s-z2s*sqrt(esti2s*(1-esti2s)/(ni2s)), esti2s+z2s*sqrt(esti2s*(1-esti2s)/(ni2s)) ) } else{if (alternative=="less"){ CI=c( 0 , esti1s+z1s*sqrt(esti1s*(1-esti1s)/(ni1s)) ) } else{if(alternative=="greater"){ CI=c(esti1s-z1s*sqrt(esti1s*(1-esti1s)/(ni1s)), 1 ) } else {stop("alternative mis-specified")}}} CI } "binBlaker" <- function (n,y,conf.level=0.95, tolerance=1e-04, alternative="two.sided") { acceptbin <- function(y,n,p) { p1 = 1-pbinom(y-1, n, p) p2 = pbinom(y, n, p) a1 = p1 + pbinom( qbinom(p1,n,p)-1, n, p ) a2 = p2+1-pbinom( qbinom(1-p2,n,p), n, p ) return(min(a1,a2)) } lower<-0 upper<-1 if(y!=0) {lower<-qbeta((1-conf.level)/2, y, n-y+1) {while(acceptbin(y,n,lower+tolerance)<(1-conf.level)) lower=lower+tolerance} } if(y!=n) {upper<-qbeta(1-(1-conf.level)/2, y+1, n-y) {while(acceptbin(y,n,upper-tolerance)<(1-conf.level)) upper=upper-tolerance} } c(lower, upper) } "binCP" <- function(n, y, conf.level=0.95, alternative="two.sided") { lower<-0 upper<-1 if(alternative=="two.sided") { if(y!=0) {lower<-qbeta((1-conf.level)/2, y, n-y+1)} if(y!=n) {upper<-qbeta(1-(1-conf.level)/2, y+1, n-y)} } if(alternative=="less") { if(y!=n) {upper<-qbeta(1-(1-conf.level), y+1, n-y)} } if(alternative=="greater") { if(y!=0) {lower<-qbeta((1-conf.level), y, n-y+1)} } c(lower,upper) } "binCI" <- function(n, y, conf.level=0.95, alternative="two.sided", method="CP") { if(length(n)!=1 || (n<1 | abs(round(n)-n) > 1e-07)){stop("number of groups n must be specified as a single integer > 0")} if(length(y)!=1 || (y<0 | abs(round(y)-y) > 1e-07)){stop("observed number of positive groups y must be specified as a single integer>0")} if(y>n) {stop("number of positive tests y can not be greater than number of groups n")} if( length(conf.level)!=1 || conf.level<0 || conf.level>1){stop("conf.level must be a positive number between 0 and 1, usually 0.95")} method<-match.arg(method, choices=c("CP","Blaker","AC","Score","Wald","SOC")) alternative<-match.arg(alternative, choices=c("two.sided","less","greater")) estimate=y/n switch(method, "CP"={conf.int<-binCP(n=n, y=y, conf.level=conf.level, alternative=alternative)}, "Blaker"={ if(alternative=="less" || alternative=="greater"){ warning("The Blaker CI is inherently two-sided.") conf.int<-c(NA, NA) } if(alternative=="two.sided") {conf.int<-binBlaker(n=n, y=y, conf.level=conf.level)} }, "Score"={conf.int<-binWilson(n=n, y=y, conf.level=conf.level, alternative=alternative)}, "AC"={conf.int<-binAC(n=n, y=y, conf.level=conf.level, alternative=alternative)}, "Wald"={conf.int<-binWald(n=n, y=y, conf.level=conf.level, alternative=alternative)}, "SOC"={conf.int<-binSOC(n=n, y=y, conf.level=conf.level, alternative=alternative)} ) out<-list(conf.int=conf.int, estimate=estimate, method=method, conf.level=conf.level, alternative=alternative) class(out)<-"binCI" out } "binSOC" <- function(n,y,conf.level=0.95,alternative="two.sided") { esti<-y/n kappa<-qnorm(conf.level) eta<-(kappa^2)/3 + 1/6 gamma1<-((13/18)*kappa^2 + 17/18)*(-1) gamma2<-(kappa^2)/18 + 7/36 midpo<-(y+eta)/(n+2*eta) if(alternative=="less") {CI=c( 0 , midpo + kappa * sqrt(esti*(1-esti) + (gamma1*esti*(1-esti) + gamma2)/n)/sqrt(n) )} if(alternative=="greater") {CI=c( midpo - kappa*sqrt(esti*(1-esti) + (gamma1*esti*(1-esti) + gamma2)/n)/sqrt(n) , 1)} if (alternative=="two.sided") { kappa<-qnorm(1-(1-conf.level)/2) eta<-(kappa^2)/3 + 1/6 gamma1<-((13/18)*kappa^2 + 17/18)*(-1) gamma2<-(kappa^2)/18 + 7/36 CI=c( midpo - kappa*sqrt(esti*(1-esti) + (gamma1*esti*(1-esti) + gamma2)/n)/sqrt(n) , midpo + kappa*sqrt(esti*(1-esti) + (gamma1*esti*(1-esti) + gamma2)/n)/sqrt(n) ) } CI } "binWald" <- function(n, y, conf.level=0.95, alternative="two.sided") { alpha=1-conf.level est=y/n z1s=qnorm(conf.level) z2s=qnorm(1-alpha/2) if(alternative=="two.sided"){ KI=c(est-z2s*sqrt(est*(1-est)/(n)), est+z2s*sqrt(est*(1-est)/(n)) ) } else{if (alternative=="less"){ KI=c( 0 , est+z1s*sqrt(est*(1-est)/(n)) ) } else{if(alternative=="greater"){ KI=c(est-z1s*sqrt(est*(1-est)/(n)), 1 ) } else {stop("alternative mis-specified")}}} KI } "binWilson" <- function(n,y,conf.level=0.95,alternative="two.sided") { alpha=1-conf.level t=y/n if(alternative =="two.sided"){ est.int=(y+(qnorm(1-alpha/2)^2)/2)/(n+(qnorm(1-alpha/2))^2) w.se=((qnorm(1-alpha/2))*sqrt(n*t*(1-t)+(qnorm(1-alpha/2)^2)/4))/(n+qnorm(1-alpha/2)^2) CI=c( est.int-w.se, est.int+w.se ) } else{if(alternative=="less"){ est.int=(y+(qnorm(1-alpha)^2)/2)/(n+(qnorm(1-alpha))^2) w.se=((qnorm(1-alpha))*sqrt(n*t*(1-t)+(qnorm(1-alpha)^2)/4))/(n+qnorm(1-alpha)^2) CI=c( 0, est.int+w.se ) } else{if(alternative=="greater"){ est.int=(y+(qnorm(1-alpha)^2)/2)/(n+(qnorm(1-alpha))^2) w.se=((qnorm(1-alpha))*sqrt(n*t*(1-t)+(qnorm(1-alpha)^2)/4))/(n+qnorm(1-alpha)^2) CI=c( est.int-w.se , 1 ) } else{stop("argument alternative misspecified")}}} CI }
.calculateLabelPositions <- function(object, x, y, peakLabels, adj, cex, srt, maxSteps=100L) { i <- sort.int(y, index.return=TRUE)$ix rects <- .textLabelRects(x[i], y[i], peakLabels[i], adj=adj, cex=cex, srt=srt) for (j in seq_along(x)) { rects[j, ] <- .testLabelOverlap(object, rects, currentIndex=j, maxSteps=maxSteps) } rects[i, ] <- rects rects } .testLabelOverlap <- function(object, rects, currentIndex, maxSteps) { r <- pi / 180L * c(90, as.vector(rbind(seq(80L, 40L, by=-10L), seq(100L, 140L, by=10L)))) testrects <- rbind(matrix(c(object@mass, rep(0L, length(object)), object@mass, object@intensity), ncol=4L), rects[seq_len(currentIndex - 1L), c("x0", "y0", "x1", "y1")]) for (k in 0L:maxSteps) { s <- k / 4L cur <- rects[currentIndex, ] cur[c("y0", "y1", "y")] <- cur[c("y0", "y1", "y")] + s * cur["h"] for (l in r) { oldcur <- cur cur[c("y0", "y1", "y")] <- cur[c("y0", "y1", "y")] + sin(l) * s * cur["h"] cur[c("x0", "x1", "x")] <- cur[c("x0", "x1", "x")] + cos(l) * s * cur["w"] if (!.overlaps(cur, testrects)) { return(cur) } cur <- oldcur } } rects[currentIndex, ] } .textLabelRects <- function(x, y, text, adj=c(0.5, 0L), cex=0.7, srt=0, offset=c(0.0, 0.2)) { wh <- .strWH(text, srt=srt, cex=cex) offset <- t(t(wh) * offset) m <- matrix(c(x - wh[, "w"] * adj[1L] - offset[, "w"], y - wh[, "h"] * adj[2L] - offset[, "h"], x + wh[, "w"] * (1L - adj[1L]) + offset[, "w"], y + wh[, "h"] * (1L - adj[2L]) + offset[, "h"], x, y, wh[, "w"], wh[, "h"]), ncol = 8L, dimnames = list(c(), c("x0", "y0", "x1", "y1", "x", "y", "w", "h"))) if (srt) { m[, c("x0", "x1", "y0", "y1")] <- .rotate(rbind(m[, c("x0", "y0")], m[, c("x1", "y1")]), center=m[, c("x", "y")], srt=srt) if (m[1L, "x0"] > m[1L, "x1"]) { m[, c("x1", "x0")] <- m[, c("x0", "x1")] } if (m[1L, "y0"] > m[1L, "y1"]) { m[, c("y1", "y0")] <- m[, c("y0", "y1")] } m[, c("w", "h")] <- m[, c("x1", "y1")] - m[, c("x0", "y0")] } m } .overlaps <- function(a, b) { if (is.vector(b)) { b <- t(b) } any( !((a[1L] >= b[, 3L] | a[3L] <= b[, 1L]) | (a[2L] >= b[, 4L] | a[4L] <= b[, 2L]))) } .scaleFactor <- function() { usr <- par("usr") pin <- par("pin") dx <- usr[2L] - usr[1L] dy <- usr[4L] - usr[3L] (dy * pin[1L]) / (dx * pin[2L]) } .rotate <- function(x, center, srt) { stopifnot(all(dim(x)) == all(dim(center))) a <- pi * srt / 180L cosa <- cos(a) sina <- sin(a) dx <- x[, 1L] - center[, 1L] dy <- x[, 2L] - center[, 2L] x[, 1L] <- center[, 1L] + dx * cosa - dy * sina x[, 2L] <- center[, 2L] + dx * sina + dy * cosa x } .strWH <- function(text, srt, cex=0.7, scale=.scaleFactor()) { a <- pi * srt / 180L scale <- abs(cos(a) + sin(a) * scale) matrix(c(strwidth(text, cex=cex) * scale, strheight(text, cex=cex) / scale), ncol = 2L, dimnames = list(c(), c("w", "h"))) }
Subsplit <- function (splits, tips, keepAll = FALSE, unique = TRUE) { if (is.list(splits)) { lapply(splits, Subsplit, tips = tips, keepAll = keepAll, unique = unique) } else if (length(splits) == 0) { ret <- splits attr(ret, 'nTip') <- length(tips) attr(ret, 'tip.label') <- if (is.character(tips)) { tips } else { attr(splits, 'tip.label')[tips] } ret } else { allSplits <- as.Splits(as.logical(splits)[, tips]) ret <- if (keepAll) allSplits else WithoutTrivialSplits(allSplits) if (unique) unique(ret) else ret } } TrivialSplits <- function (splits, nTip = attr(splits, 'nTip')) { inSplit <- TipsInSplits(splits) inSplit < 2L | inSplit > nTip - 2L } WithoutTrivialSplits <- function (splits, nTip = attr(splits, 'nTip')) { splits[[!TrivialSplits(splits, nTip)]] } CompatibleSplits <- function (splits, splits2) { splits <- as.Splits(splits) nTip <- attr(splits, 'nTip') splits2 <- as.Splits(splits2, splits) apply(splits2, 1, function (split) apply(splits, 1, .CompatibleSplit, split, nTip)) } .CompatibleSplit <- function (a, b, nTip) { rawMask <- if (nTip %% 8L) { as.raw(c(2^(nTip %% 8L) - 1L, rep.int(255L, nTip %/% 8))) } else { rep.int(as.raw(255), nTip %/% 8L) } .CompatibleRaws(a, b, rawMask) } .CompatibleRaws <- function (rawA, rawB, bitmask) { !any(as.logical(rawA & rawB)) || !any(as.logical(rawA & !rawB)) || !any(as.logical(!rawA & rawB)) || !any(as.logical(!rawA & !rawB & bitmask)) } SplitMatchProbability <- function (split1, split2) { if (NTip(split1) != NTip(split2)) stop("Splits pertain to different tips") split1 <- as.logical(split1) split2 <- as.logical(as.Splits(split2, split1)) partitions <- c(sum(split1 & split2), sum(split1 & !split2), sum(!split1 & split2), sum(!split1 & !split2)) split1Size <- .rowSums(partitions, 2, 2) split2Size <- .colSums(partitions, 2, 2) A1 <- split1Size[1] A2 <- split2Size[1] B2 <- split2Size[2] n <- sum(partitions) minA1B2 <- max(0, A1 - A2) iMax <- min(A1, B2) minB1A2 <- B2 - iMax nArrangements <- iMax - minA1B2 + 1L arrangements <- vapply(minA1B2:iMax, function (i) c(A1 - i, i, i + A2 - A1, B2 - i), double(4)) extraTipsInPerfectMatch.A1A2.B1B2 <- sum(arrangements[c(1, 4), nArrangements]) extraTipsInPerfectMatch.A1B2.B1A2 <- sum(arrangements[c(2, 3), 1L]) ranking <- if (extraTipsInPerfectMatch.A1A2.B1B2 > extraTipsInPerfectMatch.A1B2.B1A2) { c(seq.int(1L, nArrangements, 2L), rev(seq.int(2L, nArrangements, 2L))) } else if (extraTipsInPerfectMatch.A1A2.B1B2 < extraTipsInPerfectMatch.A1B2.B1A2) { c(seq.int(2L, nArrangements, 2L), rev(seq.int(1L, nArrangements, 2L))) } else { c(seq.int(1L, nArrangements, 2L), rev(seq.int(2L, nArrangements, 2L)) - 1) } choices <- apply(arrangements, 2, NPartitionPairs) sum(choices[ranking <= ranking[partitions[3] + 1L - minA1B2]]) / choose(n, A1) } LnSplitMatchProbability <- function (split1, split2) { log(SplitMatchProbability(split1, split2)) } TipLabels <- function (x, single = TRUE) UseMethod('TipLabels') TipLabels.matrix <- function (x, single = TRUE) colnames(x) TipLabels.phylo <- function (x, single = TRUE) x$tip.label TipLabels.default <- function (x, single = TRUE) attr(x, 'tip.label') TipLabels.phyDat <- function (x, single = TRUE) names(x) TipLabels.TreeNumber <- TipLabels.default TipLabels.Splits <- TipLabels.default TipLabels.list <- function (x, single = FALSE) { if (!is.null(attr(x, 'tip.label'))) return (attr(x, 'tip.label')) xTipLabel <- x$tip.label if (!is.null(xTipLabel)) { if (is.list(xTipLabel) && !is.null(xTipLabel$tip.label)) { return(xTipLabel$tip.label) } else { return(xTipLabel) } } .ListLabels(x, single, TipLabels) } AllTipLabels <- function (x) UseMethod('AllTipLabels') AllTipLabels.list <- function (x) { unique(unlist(lapply(x, TipLabels))) } AllTipLabels.multiPhylo <- AllTipLabels.list AllTipLabels.phylo <- function(x) TipLabels.phylo(x) AllTipLabels.Splits <- function (x) TipLabels.Splits(x) AllTipLabels.TreeNumber <- function (x) TipLabels.TreeNumber(x) AllTipLabels.matrix <- function (x) TipLabels.matrix(x) .ListLabels <- function (x, single, Func) { if (length(x)) { if (single) { Func(x[[1]]) } else { ret <- lapply(x, Func) uniqueRet <- unique(ret) if (length(uniqueRet) == 1) uniqueRet[[1]] else ret } } else { NULL } } TipLabels.multiPhylo <- function (x, single = FALSE) { xTipLabel <- x$tip.label if (!is.null(xTipLabel)) { if (is.list(xTipLabel) && !is.null(xTipLabel$tip.label)) { return(xTipLabel$tip.label) } else { return(xTipLabel) } } if (single) { firstEntry <- x[[1]] if (!is.null(firstEntry$tip.label)) return (firstEntry$tip.label) } else { .ListLabels(x, single, TipLabels.phylo) } } TipLabels.character <- function (x, single = TRUE) x TipLabels.numeric <- function (x, single = TRUE) { if (length(x) == 1L) { paste0('t', seq_len(x))} else { NextMethod('TipLabels', as.character(x)) } } TipLabels.phyDat <- function (x, single = TRUE) names(x) TipLabels.default <- function (x, single = TRUE) { if (is.null(names(x))) { if (any(duplicated(x))) { NULL } else { x } } else { names(x) } } NPartitionPairs <- function (configuration) { choose(sum(configuration[c(1, 3)]), configuration[1]) * choose(sum(configuration[c(2, 4)]), configuration[2]) }
get_laglead <- function(x, ...) { UseMethod("get_laglead", x) } get_laglead.default <- function(x, tz, ll_fun, ...) { LL_df <- crossing(t = x, tz = tz) %>% mutate(LL = ll_fun(.data$t, .data$tz) * 1L) %>% group_by(tz) %>% mutate(LL = lag(.data$LL, default = 0)) %>% ungroup() class(LL_df) <- c("LL_df", class(LL_df)) LL_df } get_laglead.data.frame <- function(x, ...) { time <- attr(x, "breaks") tz <- attr(x, "tz") ll_funs <- attr(x, "ll_funs") LL_df <- map2_dfr(tz, ll_funs, ~get_laglead.default(time, .x, ll_fun = .y), .id = "tz_var") if (!inherits(LL_df, "LL_df")) { class(LL_df) <- c("LL_df", class(LL_df)) } LL_df } gg_laglead <- function(x, ...) { UseMethod("gg_laglead", x) } gg_laglead.default <- function(x, tz, ll_fun, ...) { LL_df <- get_laglead(x, tz, ll_fun = ll_fun) gg_laglead(LL_df, ...) } gg_laglead.LL_df <- function( x, high_col = "grey20", low_col = "whitesmoke", grid_col = "lightgrey", ...) { x <- left_join(x, int_info(unique(x$t)), by = c("t" = "tend")) x <- x %>% filter(!is.na(.data$interval)) %>% mutate( tz = factor(.data$tz, levels = sort(unique(.data$tz), decreasing = FALSE)), interval = factor(.data$interval, levels = levels(.data$interval)) ) gg_ll <- ggplot(x, aes_string(x = "interval", y = "tz")) + geom_tile(aes_string(fill = "LL"), colour = grid_col) + scale_fill_gradient(low = low_col, high = high_col) + scale_x_discrete(expand = c(0, 0)) + scale_y_discrete(expand = c(0, 0)) + ylab(expression(t[z])) + xlab(expression(t)) if (!is.null(x[["tz_var"]])) { gg_ll <- gg_ll + facet_wrap(~tz_var, scales = "free_y") } gg_ll + theme(legend.position = "none") } gg_laglead.nested_fdf <- function(x, ...) { LL_df <- get_laglead(x) gg_laglead(LL_df, ...) }
setConstructorS3("BasePositionNormalization", function(..., model=c("smooth.spline"), df=5) { model <- match.arg(model) df <- Arguments$getInteger(df, range=c(1,1e3)) extend(LinearModelProbeSequenceNormalization(...), "BasePositionNormalization", .model = model, .df = df ) }) setMethodS3("getAsteriskTags", "BasePositionNormalization", function(this, collapse=NULL, ...) { tags <- NextMethod("getAsteriskTags", collapse=NULL) model <- this$.model if (model != "smooth.spline") { tags <- c(tags, model) } df <- this$.df if (df != 5) { tags <- c(tags, sprintf("df=%d", df)) } tags <- paste(tags, collapse=collapse) tags }, protected=TRUE) setMethodS3("getParameters", "BasePositionNormalization", function(this, ...) { params <- NextMethod("getParameters") params <- c(params, list( model = this$.model, df = this$.df )) params }, protected=TRUE) setMethodS3("getDesignMatrix", "BasePositionNormalization", function(this, cells=NULL, ..., force=FALSE, cache=TRUE, verbose=FALSE) { if (is.null(cells)) { } else { } verbose <- Arguments$getVerbose(verbose) if (verbose) { pushState(verbose) on.exit(popState(verbose)) } verbose && enter(verbose, "Retrieving design matrix") verbose && cat(verbose, "Cells:") verbose && str(verbose, cells) verbose && enter(verbose, "Getting algorithm parameters") params <- getParameters(this, expand=FALSE, verbose=less(verbose, 1)) model <- params$model df <- params$df verbose && cat(verbose, "Model: ", model) verbose && cat(verbose, "Degrees of freedom: ", df) verbose && exit(verbose) acs <- getAromaCellSequenceFile(this, verbose=less(verbose, 5)) key <- list( method="getDesignMatrix", class=class(this[1]), cells=cells, model=model, df=df, acs=list(fullname=getFullName(acs)) ) dirs <- c("aroma.affymetrix", getChipType(acs)) if (!force) { X <- loadCache(key=key, dirs=dirs) if (!is.null(X)) { verbose && cat(verbose, "Cached results found.") verbose && exit(verbose) return(X) } } verbose && enter(verbose, "Reading probe sequences") seqs <- readSequenceMatrix(acs, cells=cells, what="raw", verbose=less(verbose, 5)) acs <- NULL verbose && cat(verbose, "Probe-sequence matrix:") verbose && str(verbose, seqs) verbose && exit(verbose) verbose && enter(verbose, "Building probe-position design matrix") verbose && cat(verbose, "Degrees of freedom: ", df) X <- getProbePositionEffectDesignMatrix(seqs, df=df, verbose=less(verbose, 5)) seqs <- NULL gc <- gc() verbose && print(verbose, gc) verbose && cat(verbose, "Design matrix:") verbose && str(verbose, X) verbose && cat(verbose, "RAM: %s", hsize(object.size(X), digits = 2L, standard = "IEC")) verbose && exit(verbose) if (cache) { saveCache(X, key=key, dirs=dirs) } verbose && exit(verbose) X }, private=TRUE) setMethodS3("getSignalTransform", "BasePositionNormalization", function(this, ...) { params <- getParameters(this, expand=FALSE, ...) shift <- params$shift params <- NULL transform <- function(y, ...) { y <- y + shift y <- log2(y) y } transform }, protected=TRUE)
drill_show_schemas <- function(drill_con, .progress=interactive()) { drill_query(drill_con, "SHOW SCHEMAS", .progress = .progress) } drill_use <- function(drill_con, schema_name, .progress=interactive()) { query <- sprintf("USE `%s`", schema_name) out <- drill_query(drill_con, query, .progress = .progress) if (("errorMessage" %in% names(out))) message(str(out, 2)) invisible(out) } drill_show_files <- function(drill_con, schema_spec, .progress=interactive()) { query <- sprintf("SHOW FILES IN %s", schema_spec) drill_query(drill_con, query, uplift=TRUE, .progress = .progress) %>% dplyr::select(name, isDirectory, permissions, dplyr::everything()) }
vcovBS.lm <- function(x, cluster = NULL, R = 250, type = "xy", ..., fix = FALSE, use = "pairwise.complete.obs", applyfun = NULL, cores = NULL) { cf <- coef(x) k <- length(cf) n <- nobs(x) rval <- matrix(0, nrow = k, ncol = k, dimnames = list(names(cf), names(cf))) cf <- matrix(rep.int(NA_real_, k * R), ncol = k, dimnames = list(NULL, names(cf))) if (is.null(cluster)) cluster <- attr(x, "cluster") if (is.null(cluster)) cluster <- 1L:n if(inherits(cluster, "formula")) { cluster_tmp <- if("Formula" %in% loadedNamespaces()) { suppressWarnings(expand.model.frame(x, cluster, na.expand = FALSE)) } else { expand.model.frame(x, cluster, na.expand = FALSE) } cluster <- model.frame(cluster, cluster_tmp, na.action = na.pass) } else { cluster <- as.data.frame(cluster) } if((n != NROW(cluster)) && !is.null(x$na.action) && (class(x$na.action) %in% c("exclude", "omit"))) { cluster <- cluster[-x$na.action, , drop = FALSE] } if(NROW(cluster) != n) stop("number of observations in 'cluster' and 'nobs()' do not match") if(anyNA(cluster)) stop("cannot handle NAs in 'cluster': either refit the model without the NA observations in 'cluster' or impute the NAs") p <- NCOL(cluster) if (p > 1L) { cl <- lapply(1L:p, function(i) combn(1L:p, i, simplify = FALSE)) cl <- unlist(cl, recursive = FALSE) sign <- sapply(cl, function(i) (-1L)^(length(i) + 1L)) paste_ <- function(...) paste(..., sep = "_") for (i in (p + 1L):length(cl)) { cluster <- cbind(cluster, Reduce(paste_, unclass(cluster[, cl[[i]] ]))) } } else { cl <- list(1) sign <- 1 } if(is.function(type)) { wild <- type type <- "user" } else { wild <- function(n) NULL } type <- match.arg(gsub("wild-", "", tolower(type), fixed = TRUE), c("xy", "residual", "wild", "webb", "rademacher", "mammen", "norm", "user")) if(type == "wild") type <- "rademacher" wild <- switch(type, "rademacher" = function(n) sample(c(-1, 1), n, replace = TRUE), "mammen" = function(n) sample(c(-1, 1) * (sqrt(5) + c(-1, 1))/2, n, replace = TRUE, prob = (sqrt(5) + c(1, -1))/(2 * sqrt(5))), "norm" = function(n) rnorm(n), "webb" = function(n) sample(c(-sqrt((3:1)/2), sqrt((1:3)/2)), n, replace = TRUE), wild ) y <- if(!is.null(x$y)) { x$y } else if(!is.null(x$model)) { model.response(x$model) } else { model.response(model.frame(x)) } xfit <- if(type == "xy") model.matrix(x) else list(fit = x$fitted.values, res = x$residuals, qr = x$qr) if(is.null(applyfun)) { applyfun <- if(is.null(cores)) { lapply } else { if(.Platform$OS.type == "windows") { cl_cores <- parallel::makeCluster(cores) on.exit(parallel::stopCluster(cl_cores)) function(X, FUN, ...) parallel::parLapply(cl = cl_cores, X, FUN, ...) } else { function(X, FUN, ...) parallel::mclapply(X, FUN, ..., mc.cores = cores) } } } for (i in 1L:length(cl)) { cli <- if(type %in% c("xy", "residual")) { split(seq_along(cluster[[i]]), cluster[[i]]) } else { factor(cluster[[i]], levels = unique(cluster[[i]])) } if(type == "residual" && length(unique(sapply(cli, length))) > 1L) { warning("residual bootstrap is not well-defined for unbalanced clusters") } bootfit <- switch(type, "xy" = function(j, ...) { j <- unlist(cli[sample(names(cli), length(cli), replace = TRUE)]) lm.fit(xfit[j, , drop = FALSE], y[j], ...)$coefficients }, "residual" = function(j, ...) { j <- unlist(cli[sample(names(cli), length(cli), replace = TRUE)]) qr.coef(xfit$qr, xfit$fit + xfit$res[j]) }, function(j, ...) { j <- wild(nlevels(cli)) qr.coef(xfit$qr, xfit$fit + xfit$res * j[cli]) } ) cf <- applyfun(1L:R, bootfit, ...) cf <- do.call("rbind", cf) rval <- rval + sign[i] * cov(cf, use = use) } if(fix && any((eig <- eigen(rval, symmetric = TRUE))$values < 0)) { eig$values <- pmax(eig$values, 0) rval[] <- crossprod(sqrt(eig$values) * t(eig$vectors)) } return(rval) } vcovBS.glm <- function(x, cluster = NULL, R = 250, start = FALSE, ..., fix = FALSE, use = "pairwise.complete.obs", applyfun = NULL, cores = NULL) { cf <- coef(x) if(identical(start, TRUE)) start <- cf if(identical(start, FALSE)) start <- NULL k <- length(cf) n <- nobs(x) rval <- matrix(0, nrow = k, ncol = k, dimnames = list(names(cf), names(cf))) cf <- matrix(rep.int(NA_real_, k * R), ncol = k, dimnames = list(NULL, names(cf))) if (is.null(cluster)) cluster <- attr(x, "cluster") if (is.null(cluster)) cluster <- 1L:n if(inherits(cluster, "formula")) { cluster_tmp <- if("Formula" %in% loadedNamespaces()) { suppressWarnings(expand.model.frame(x, cluster, na.expand = FALSE)) } else { expand.model.frame(x, cluster, na.expand = FALSE) } cluster <- model.frame(cluster, cluster_tmp, na.action = na.pass) } else { cluster <- as.data.frame(cluster) } if((n != NROW(cluster)) && !is.null(x$na.action) && (class(x$na.action) %in% c("exclude", "omit"))) { cluster <- cluster[-x$na.action, , drop = FALSE] } if(NROW(cluster) != n) stop("number of observations in 'cluster' and 'nobs()' do not match") if(anyNA(cluster)) stop("cannot handle NAs in 'cluster': either refit the model without the NA observations in 'cluster' or impute the NAs") p <- NCOL(cluster) if (p > 1L) { cl <- lapply(1L:p, function(i) combn(1L:p, i, simplify = FALSE)) cl <- unlist(cl, recursive = FALSE) sign <- sapply(cl, function(i) (-1L)^(length(i) + 1L)) paste_ <- function(...) paste(..., sep = "_") for (i in (p + 1L):length(cl)) { cluster <- cbind(cluster, Reduce(paste_, unclass(cluster[, cl[[i]] ]))) } } else { cl <- list(1) sign <- 1 } y <- if(!is.null(x$y)) { x$y } else if(!is.null(x$model)) { model.response(x$model) } else { model.response(model.frame(x)) } xfit <- model.matrix(x) if(is.null(applyfun)) { applyfun <- if(is.null(cores)) { lapply } else { if(.Platform$OS.type == "windows") { cl_cores <- parallel::makeCluster(cores) on.exit(parallel::stopCluster(cl_cores)) function(X, FUN, ...) parallel::parLapply(cl = cl_cores, X, FUN, ...) } else { function(X, FUN, ...) parallel::mclapply(X, FUN, ..., mc.cores = cores) } } } for (i in 1L:length(cl)) { cli <- split(seq_along(cluster[[i]]), cluster[[i]]) bootfit <- function(j, ...) { j <- unlist(cli[sample(names(cli), length(cli), replace = TRUE)]) glm.fit(xfit[j, , drop = FALSE], y[j], family = x$family, start = start, ...)$coefficients } cf <- applyfun(1L:R, bootfit, ...) cf <- do.call("rbind", cf) rval <- rval + sign[i] * cov(cf, use = use) } if(fix && any((eig <- eigen(rval, symmetric = TRUE))$values < 0)) { eig$values <- pmax(eig$values, 0) rval[] <- crossprod(sqrt(eig$values) * t(eig$vectors)) } return(rval) }
util_sixsigma <- function(x) { xmu <- mean(x, na.rm = TRUE) xsd <- sd(x, na.rm = TRUE) lth <- xmu - 3 * xsd uth <- xmu + 3 * xsd xbin <- ifelse(x < lth | x > uth, 1, 0) return(xbin) }
setMethod( f = "getNumberOfStrata", signature = signature( object = "CompactStratification" ), definition = function(object) { length(unique(object@stratumId)) } )
library(utils) args <- commandArgs(TRUE) DESCRIPTION <- readLines("DESCRIPTION") idx <- grep("^Version:", DESCRIPTION) field <- DESCRIPTION[[idx]] bumpedDescVersion <- if (!grepl("-", DESCRIPTION[[idx]])) { paste(field, "-1", sep = "") } else { minorVersion <- as.numeric(gsub(".*-", "", DESCRIPTION[[idx]])) minorVersion <- minorVersion + 1 gsub("-.*", paste("-", minorVersion, sep = ""), DESCRIPTION[[idx]]) } version <- if (length(args)) { paste("Version:", args[[1]]) } else { bumpedDescVersion } DESCRIPTION[[idx]] <- version cat(DESCRIPTION, file = "DESCRIPTION", sep = "\n") source("R/update.R") updateInit()
leecarter.estimate <- function(mx, ax.index = NULL, ax.smooth = FALSE, bx.postprocess = TRUE, nx = 5) { if(length(dim(mx)) < 2 || ncol(mx) < 2) stop("mx must be a matrix (age x time) of at least two columns.") lmx <- log(mx) if(length(dim(lmx))==0) lmx <- as.matrix(lmx) if(is.null(rownames(lmx))) rownames(lmx) <- if(nx > 1) c(0,1, seq(nx, by=nx, length=nrow(lmx)-2)) else 0:(nrow(lmx)-1) nest <- ncol(lmx) if(is.null(ax.index)) ax.index <- 1:nest ax <- apply(lmx[,ax.index, drop=FALSE], 1, sum, na.rm=TRUE) / length(ax.index) if(ax.smooth) { ax.sm <- smooth.spline(ax, df=ceiling(length(ax)/2))$y ax[-1] <- ax.sm[-1] } kt <- apply(lmx, 2, sum) - sum(ax) bx <- bx.estimate(lmx, ax, kt, postprocess = bx.postprocess) return(list(ax = ax, bx = bx, kt = kt, nx = nx)) } bx.estimate <- function(lmx, ax, kt, postprocess=TRUE) { x2 <- sum(kt*kt) x1 <- rep(NA, nrow(lmx)) for (i in 1:nrow(lmx)) x1[i] <- sum((lmx[i,]-ax[i])*kt) bx <- x1/x2 if(postprocess) bx <- .finish.bx(bx) names(bx) <- rownames(lmx) return(bx) } .finish.bx <- function(bx) { negbx <- which(bx <= 0) lnegbx <- length(negbx) if(lnegbx > 0 && negbx[1] == 1) { bx[1] <- 0 negbx <- if(lnegbx > 1) negbx[2:lnegbx] else c() lnegbx <- length(negbx) } while(lnegbx > 0) { bx[negbx] <- 0.5 * bx[negbx-1] negbx <- which(bx < 0) lnegbx <- length(negbx) } lbx <- length(bx) for (i in 1:(lbx-1)) { if (bx[lbx+1 - i] == 0) bx[lbx+1 - i] <- bx[lbx - i] } bx <- bx/sum(bx) return(bx) } lileecarter.estimate <- function(mxM, mxF, nx = 5, ...) { lc.male <- leecarter.estimate(mxM, nx = nx, ...) lc.female <- leecarter.estimate(mxF, nx = nx, ...) if(length(lc.female$ax) != length(lc.male$ax) || length(lc.female$kt) != length(lc.male$kt)) stop("Mismatch in dimensions of male and female mortality. Check the mxM and mxF arguments.") bx <- (lc.male$bx + lc.female$bx)/2 ages <- as.integer(names(lc.female$bx)) nx <- ages[4] - ages[3] return(list(bx = bx, ultimate.bx = ultimate.bx(bx), ages = ages, nx = nx, female=list(ax=lc.female$ax, bx=bx, kt=lc.female$kt, sex.bx = lc.female$bx), male=list(ax=lc.male$ax, bx=bx, kt=lc.male$kt, sex.bx = lc.male$bx) )) } rotate.leecarter <- function(bx, ultimate.bx, e0, e0l = 80, e0u = 102, p = 0.5) { npred <- length(e0) wt <- (e0 - e0l)/(e0u-e0l) wst <- (0.5*(1+(sin(pi/2*(2*wt-1)))))^p Bxt <- matrix(NA, nrow=length(bx), ncol=npred) for(t in 1:npred) { Bxt[,t] <- switch(cut(e0[t], c(0, e0l, e0u, 9999), labels=FALSE, right=FALSE), bx, (1-wst[t])*bx + wst[t]*ultimate.bx, ultimate.bx) } dimnames(Bxt) <- list(names(bx), names(e0)) return(Bxt) } ultimate.bx <- function(bx) { bux <- bx lbx <- length(bx) idx15 <- which(names(bx) == 15) idx60 <- which(names(bx) == 60) bux[1:idx60] <- mean(bux[idx15:idx60]) bux[(idx60+1):lbx] <- bux[(idx60+1):lbx] * (bux[idx60]/bux[idx60+1]) return(bux/sum(bux)) } .kranges <- function(Bxt, axm, axf) { lmin <- -12 lmax <- 0 machine.max <- log(.Machine$double.xmax) machine.min <- log(.Machine$double.xmin) npred <- ncol(Bxt) kranges <- list(male=list(), female=list()) ax <- list(male=axm, female=axf) bx.lim <- rbind(apply(Bxt, 2, function(x) min(x[x>0])), apply(Bxt, 2, function(x) max(x[x>0]))) for(sex in c("male", "female")) { kranges[[sex]]$kl <- pmin((lmax - apply(ax[[sex]], 2, max))/bx.lim[2,], machine.max) kranges[[sex]]$ku <- pmax((lmin - apply(ax[[sex]], 2, min))/bx.lim[1,], machine.min) } return(kranges) } mortcast <- function (e0m, e0f, lc.pars, rotate = TRUE, keep.lt = FALSE, constrain.all.ages = FALSE, ...) { get.a0rule <- function(a0rule = c("ak", "cd"), ...) list(ak = 1, cd = 2)[[match.arg(a0rule)]] if(length(dim(e0m)) > 0) e0m <- drop(as.matrix(e0m)) if(length(dim(e0f)) > 0) e0f <- drop(as.matrix(e0f)) e0 <- list(female=e0f, male=e0m) npred <- length(e0f) nage <- length(lc.pars$ages) if(lc.pars$nx > 1) { resnage <- nage-1 age.groups <- lc.pars$ages[-2] } else { resnage <- nage age.groups <- lc.pars$ages } a0cat <- get.a0rule(...) zeromatsr <- matrix(0, nrow=resnage, ncol=npred) zeromatmx <- matrix(0, nrow=nage, ncol=npred) ressex <- list(mx=zeromatmx, lx=zeromatsr, sr=zeromatsr, Lx=zeromatsr) result <- list(female = ressex, male = ressex) if(rotate) Bxt <- rotate.leecarter(lc.pars$bx, lc.pars$ultimate.bx, (e0f + e0m)/2) else Bxt <- matrix(lc.pars$bx, nrow=nage, ncol=npred) for(sex in c("female", "male")) if(is.null(lc.pars[[sex]]$axt)) lc.pars[[sex]]$axt <- matrix(lc.pars[[sex]]$ax, nrow=nrow(Bxt), ncol=npred) kranges <- .kranges(Bxt, lc.pars$male$axt, lc.pars$female$axt) for (sex in c("female", "male")) { LCres <- .C("LC", as.integer(npred), as.integer(c(female=2, male=1)[sex]), as.integer(nage), as.integer(lc.pars$nx), as.numeric(lc.pars[[sex]]$axt), as.numeric(Bxt), as.numeric(e0[[sex]]), Kl=as.numeric(kranges[[sex]]$kl), Ku=as.numeric(kranges[[sex]]$ku), constrain=as.integer((sex == "male") * ((sex == "male") + (constrain.all.ages == TRUE))), FMx=as.numeric(result$female$mx), FEop=as.numeric(e0$female), a0rule = as.integer(a0cat), LLm = as.numeric(result[[sex]]$Lx), Sr=as.numeric(result[[sex]]$sr), lx=as.numeric(result[[sex]]$lx), Mx=as.numeric(result[[sex]]$mx)) result[[sex]]$mx <- matrix(LCres$Mx, nrow=nage, dimnames=list(lc.pars$ages, names(e0m))) result[[sex]]$nx <- lc.pars$nx if(keep.lt) { result[[sex]]$sr <- matrix(LCres$Sr, nrow=resnage, dimnames=list(age.groups, names(e0m))) result[[sex]]$Lx <- matrix(LCres$LLm, nrow=resnage, dimnames=list(age.groups, names(e0m))) result[[sex]]$lx <- matrix(LCres$lx, nrow=resnage, dimnames=list(age.groups, names(e0m))) } else { result[[sex]]$sr <- NULL result[[sex]]$Lx <- NULL result[[sex]]$lx <- NULL } } return(result) }
setClass('lcMethodStratify', contains = 'lcMethod') setValidity('lcMethodStratify', function(object) { assert_that(has_lcMethod_args(object, formalArgs(lcMethodStratify))) if (isArgDefined(object, 'nClusters')) { assert_that(is.na(object$nClusters) || is.count(object$nClusters)) } if (isArgDefined(object, 'clusterNames')) { assert_that(is.null(object$clusterNames) || is.character(object$clusterNames)) } if (isArgDefined(object, 'center')) { assert_that(is.function(object$center)) } }) lcMethodStratify = function( response, stratify, center = meanNA, nClusters = NaN, clusterNames = NULL, time = getOption('latrend.time'), id = getOption('latrend.id'), name = 'stratify' ) { mc = match.call.all() mc$Class = 'lcMethodStratify' do.call(new, as.list(mc)) } setMethod('getArgumentDefaults', signature('lcMethodStratify'), function(object) { c( formals(lcMethodStratify), callNextMethod() ) }) setMethod('getName', signature('lcMethodStratify'), function(object) { if (isArgDefined(object, 'name') && !is.null(object$name)) { return(object$name) } if (isArgDefined(object, 'stratify')) { expr = object[['stratify', eval = FALSE]] if (is.name(fun)) { return(paste('stratification ', expr)) } } return('stratify') }) setMethod('getShortName', signature('lcMethodStratify'), function(object) 'strat') setMethod('compose', signature('lcMethodStratify'), function(method, envir = NULL, ...) { evaluate.lcMethod( method, try = FALSE, exclude = 'stratify', envir = envir ) }) setMethod('fit', signature('lcMethodStratify'), function(method, data, envir, verbose, ...) { data = as.data.table(data) id = idVariable(method) strat = method[['stratify', eval = FALSE]] assignments = .stratifyTrajectories( strat, data = data, id = id, envir = environment(method) ) if (is.factor(assignments)) { assert_that(is.na(method$nClusters) || nlevels(assignments) == method$nClusters) } intAssignments = as.integer(assignments) assert_that(is.na(method$nClusters) || max(intAssignments) <= method$nClusters) if (is.na(method$nClusters)) { if (is.factor(assignments)) { numClus = nlevels(assignments) } else { numClus = max(intAssignments) } } else { numClus = method$nClusters } assert_that(min(intAssignments) >= 1, max(intAssignments) <= numClus) if (is.null(method$clusterNames)) { if (is.factor(assignments)) { clusNames = levels(assignments) } else { clusNames = make.clusterNames(numClus) } } else { assert_that(is.character(method$clusterNames)) clusNames = method$clusterNames } assert_that(length(clusNames) == numClus) if (numClus > 1) { clusterSizes = table(intAssignments) if (numClus > 1 && uniqueN(intAssignments) == 1) { warning( sprintf( 'Stratification assigned all trajectories to the same cluster ("%s").', clusNames[clusterSizes > 0][1] ) ) } else if (uniqueN(intAssignments) < numClus) { warning( sprintf( 'Cluster(s) "%s" were not assigned any trajectories during stratification.', paste0(clusNames[clusterSizes == 0], collapse = '", "') ) ) } } .lcModelStratify( method = method, data = data, id = id, time = timeVariable(method), center = method$center, response = responseVariable(method), clusterNames = clusNames, trajectoryClusterIndices = intAssignments, name = method$name ) }) .stratifyTrajectories = function(strat, data, id, envir = parent.frame()) { assert_that( is.data.table(data), is.call(strat) || is.name(strat) ) numIds = uniqueN(data[[id]]) if (is.name(strat) || is.call(strat) && strat[[1]] == 'function') { stratfun = eval(strat, envir = envir) out = data[, .(Cluster = stratfun(.SD)), by = c(id)] } else { out = data[, .(Cluster = eval(strat)), by = c(id)] } assert_that(length(out) == 2, msg = 'expected scalar output from the stratification function. got multiple columns as output') assert_that(is.logical(out[['Cluster']]) || is.numeric(out[['Cluster']]) || is.factor(out[['Cluster']])) assert_that(nrow(out) == numIds, msg = 'expected scalar output from the stratification function. got multiple values per id') assert_that(all(is.finite(out[['Cluster']])), msg = 'some ids are assigned to NA') if (is.logical(out[['Cluster']])) { out[, Cluster := as.integer(Cluster) + 1L] } ids = make.ids(data[[id]]) out[match(ids, get(id)), Cluster] } postprobFromAssignments = function(assignments, k) { assert_that( is.count(k), is.integer(assignments), all(is.finite(assignments)), min(assignments) >= 1, max(assignments) <= k ) postprob = matrix(0, nrow = length(assignments), ncol = k) idxMat = cbind(seq_along(assignments), assignments) postprob[idxMat] = 1 return(postprob) } meanNA = function(x, ...) { mean(x, ..., na.rm = TRUE) } weighted.meanNA = function(x, w, ...) { weighted.mean(x, w = w, ..., na.rm = TRUE) }
ok <- function(model, beta = NULL ){ d <- model@d n <- model@n X <- model@X y <- model@y if(is.null(beta)){ beta <- [email protected] } y_centred <- y - beta T <- model@T cov_function <- model@covariance sigma_0_2 <- model@covariance@sd2 + ifelse(model@[email protected], model@covariance@nugget, 0) sigma_0 <- sqrt(sigma_0_2) Kinv <- chol2inv(T) sigma_beta = sqrt(1/sum(Kinv)) xi <- local({ X <- X Kinv <- Kinv y_centred <- y_centred beta <- beta sigma_0 <- sigma_0 sigma_beta <- sigma_beta cov_function <- cov_function function(x){ kn <- DiceKriging::covMat1Mat2(object = cov_function, X1 = X, X2 = t(x), nugget.flag = TRUE) Kinv_kn <- Kinv %*% kn mean <- c(t(Kinv_kn) %*% y_centred + beta) sd_sk_2 <- sigma_0^2 - colSums(kn*Kinv_kn) if(sum(sd_sk_2<0)>0){ sd_sk_2[sd_sk_2<0] <- 0 } sd_beta_2 <- sigma_beta^2*(colSums(Kinv_kn) - 1)^2 sd <- sqrt(sd_sk_2 + sd_beta_2) return(list(mean=mean,sd=sd, kn=kn, Kinv_kn=Kinv_kn)) } }) updateSd <- local({ Kinv <- Kinv y_centred <- y_centred beta <- beta sigma_0 <- sigma_0 sigma_beta <- sigma_beta cov_function <- cov_function function(x, Xnew, xi_x, xi_Xnew){ r <- dim(as.matrix(Xnew))[2] if(r==1) { K_rr <- sigma_0^2 } else { K_rr <- DiceKriging::covMatrix(object = cov_function, X = t(Xnew))$C } K_nr <- as.matrix(xi_Xnew$kn) Kinv_Knr <- as.matrix(xi_Xnew$Kinv_kn) sd_beta <- (colSums(Kinv_Knr) - 1) if(r==1){ sd_beta_2 <- sigma_beta^2*sd_beta^2 } else { sd_beta_2 <- sigma_beta^2*as.matrix(sd_beta)%*%sd_beta } Sigma_rr <- K_rr - t(K_nr) %*% Kinv_Knr + sd_beta_2 k_r <- DiceKriging::covMat1Mat2(object = cov_function, X1 = t(Xnew), X2 = t(x), nugget.flag = TRUE) k_n <- as.matrix(xi_x$kn) chi_r = k_r - t(Kinv_Knr) %*% k_n + sigma_beta^2*as.matrix(sd_beta)%*%(colSums(xi_x$Kinv_kn) - 1) if( r==1) { Sigma_rr_inv = 1/Sigma_rr } else { Sigma_rr_inv <- chol2inv(chol(Sigma_rr)) } if(r==1){ sd_sk_2 <- colSums(chi_r^2)*Sigma_rr_inv } else { sd_sk_2 <- colSums(chi_r*(Sigma_rr_inv%*%chi_r)) } sd <- sqrt(pmax(xi_x$sd^2 - sd_sk_2, 0)) return(sd) } }) updateSdfast <- local({ sigma_beta <- sigma_beta cov_function <- cov_function function(x, xi_x){ Nsur <- dim(x)[2] Sigma_r_inv <- matrix(1, nrow = Nsur, ncol = Nsur)/xi_x$sd^2 K_xx <- DiceKriging::covMatrix(object = cov_function, X = t(x))$C chi_r <- K_xx - t(xi_x$kn) %*% xi_x$Kinv_kn + sigma_beta^2 * (colSums(xi_x$Kinv_kn) - 1) %*% t((colSums(xi_x$Kinv_kn) - 1)) sd_old_2 <- t(matrix(1, nrow = Nsur, ncol = Nsur)*xi_x$sd^2) sd_nr_2 <- pmax(sd_old_2 - chi_r^2*Sigma_r_inv, 0) return(sd_nr_2) } }) res <- list(Kinv = Kinv, beta = beta, y_centred = y_centred, sigma_beta = sigma_beta, xi = xi, updateSd = updateSd, updateSdfast = updateSdfast ) class(res) <- 'ok' return(res) }
RegistryToBMR = function(reg, learners, measures, imputeMissing = TRUE) { res = reduceResultsList(reg, ids = findDone(reg), fun = function(job, res) { tsk = res$resample.res$task.id lrn = res$resample.res$learner.id dat = res$resample.res lst = eval(parse(text = paste0("list(", tsk, "= list(", lrn, "= dat))"))) } ) allLrns = c() for (i in seq_along(learners)) { allLrns = c(allLrns, learners[[i]]$id) } nLrns = length(unique(allLrns)) r = list() for (i in seq_along(res)) { tnm = names(res[[i]])[1] lnm = names(res[[i]][[tnm]])[1] r[[tnm]][[lnm]] = res[[i]][[tnm]][[lnm]] } newBMR = list(results = r, measures = measures, learners = learners) class(newBMR) = "BenchmarkResult" if (!imputeMissing) { rClean = newBMR$results for (i in seq_along(r)) { if (length(r[[i]]) < nLrns) { print(paste0("Deleting task: ", names(r)[i])) rClean[[names(r)[i]]] = NULL } } newBMR$results = rClean } if (imputeMissing) { imputeMissingResampRes = function(learner, task) { load("impute.RData") imp$learner.id = learner imp$task.id = task return(imp) } imputeBMR = function(bmr) { for (i in seq_along(bmr$results)) { if (length(bmr$results[[i]]) < nLrns) { missing = setdiff(allLrns, names(bmr$results[[i]])) for (j in seq_along(missing)) { imp = imputeMissingResampRes(missing[[j]], names(bmr$results)[i]) eval(parse(text = paste0("bmr$results[[", i, "]][['", missing[[j]], "']] = imp"))) } } } return(bmr) } newBMR = imputeBMR(newBMR) } return(newBMR) } if (FALSE) { tsk = list(iris.task, sonar.task) lrns = list(makeLearner("classif.rpart"), makeLearner("classif.nnet")) rdesc = makeResampleDesc("CV", iters = 10) meas = list(mmce, ber, timetrain, timepredict) bmr = benchmark(lrns, tsk, rdesc, meas) str(bmr, max.level = 1) bmr$measures bmr$learners str(bmr$results, max.level = 1) str(bmr$results[[1]], max.level = 1) res = reduceResultsList(reg, ids = findDone(reg)) for (i in seq_along(res)) { z = c(z, res[[i]]$resample.res$task.id) t = c(t, res[[i]]$resample.res$learner.id) } length(unique(t)) if (FALSE) { impute = resample(learner = makeLearner("classif.rpart"), task = iris.task, resampling = makeResampleDesc("CV", iters = 10), measures = list(mmce, ber, timetrain, timepredict)) impute$measures.test$mmce = 1L impute$measures.test$ber = 1L impute$measures.test$timetrain = 3600L impute$measures.test$timepredict = 3600L impute$aggr = c(1L, 1L, 3600L, 3600L) names(impute$aggr) = c("mmce.test.mean", "ber.test.mean", "timetrain.test.mean", "timepredict.test.mean") impute$pred = "imputed" impute$measures.train = data.frame(c("imputed")) impute$err.msgs = "imputed" impute$models = "imputed" impute$runtime = 3600 * 10 imp = impute save(imp, file = "impute.RData") } resample(learner = makeLearner("classif.obliqueRF"), task = toMlr(getOMLTask(3627))$mlr.task, measures = mmce, resampling = makeResampleDesc("CV", iters = 10)) }
`getDividends` <- function(Symbol,from='1970-01-01',to=Sys.Date(),env=parent.frame(),src='yahoo', auto.assign=FALSE,auto.update=FALSE,verbose=FALSE,split.adjust=TRUE,..., curl.options=list()) { tmp.symbol <- Symbol if(missing(env)) { env <- parent.frame(1) } else { if(exists(Symbol, envir = env, inherits = FALSE)) { tmp.symbol <- get(Symbol, envir = env) } if(!missing(auto.assign) && !isTRUE(auto.assign) && !is.null(env)) { warning("ignoring 'auto.assign = FALSE' because 'env' is specified") } auto.assign <- TRUE } if(is.null(env)) auto.assign <- FALSE Symbol.name <- ifelse(!is.character(Symbol), deparse(substitute(Symbol)), as.character(Symbol)) from.posix <- .dateToUNIX(from) to.posix <- .dateToUNIX(to) handle <- .getHandle() yahoo.URL <- .yahooURL(Symbol.name, from.posix, to.posix, "1d", "div", handle) conn <- curl::curl(yahoo.URL,handle=handle$ch) fr <- try(read.csv(conn, as.is=TRUE), silent = TRUE) if (inherits(fr, "try-error")) { fr <- retry.yahoo(Symbol.name, from.posix, to.posix, "1d", "div", conn) } fr <- xts(fr[,2],as.Date(fr[,1])) colnames(fr) <- paste(Symbol.name,'div',sep='.') if(src[1] == "yahoo" && split.adjust) { splits <- getSplits(Symbol.name, from="1900-01-01") if(is.xts(splits) && is.xts(fr) && nrow(splits) > 0 && nrow(fr) > 0) { fr <- fr * adjRatios(splits=merge(splits, index(fr)))[,1] } } if(is.xts(tmp.symbol)) { if(auto.update) { xtsAttributes(tmp.symbol) <- list(dividends=fr) assign(Symbol.name,tmp.symbol,envir=env) } } else if(auto.assign) { assign(paste(Symbol.name,'div',sep='.'),fr,envir=env) } else fr }
library(sf) test_that("st_network_bbox combines the bounding box of nodes and edges", { rdm_rox = roxel[sample(nrow(roxel), 50), ] net = as_sfnetwork(rdm_rox) expect_true( all(names(st_network_bbox(net)) == c("xmin", "ymin", "xmax", "ymax")) ) expect_true( st_network_bbox(net)["xmin"] <= st_bbox(activate(net, "nodes"))["xmin"] ) expect_true( st_network_bbox(net)["xmin"] <= st_bbox(activate(net, "edges"))["xmin"] ) expect_true( st_network_bbox(net)["ymin"] <= st_bbox(activate(net, "nodes"))["ymin"] ) expect_true( st_network_bbox(net)["ymin"] <= st_bbox(activate(net, "edges"))["ymin"] ) expect_true( st_network_bbox(net)["xmax"] >= st_bbox(activate(net, "nodes"))["xmax"] ) expect_true( st_network_bbox(net)["xmax"] >= st_bbox(activate(net, "edges"))["xmax"] ) expect_true( st_network_bbox(net)["ymax"] >= st_bbox(activate(net, "nodes"))["ymax"] ) expect_true( st_network_bbox(net)["ymax"] >= st_bbox(activate(net, "edges"))["ymax"] ) })
observeEvent(input$analyzeBtn, { withBusyIndicator("analyzeBtn", { html("analyzeProgress", "") withCallingHandlers( dataValues$plate <- dataValues$plate %>% analyze(restart = TRUE), message = function(m) { html("analyzeProgress", m$message, TRUE) }, warning = function(m) { html("analyzeProgress", paste0(m$message, "\n"), TRUE) } ) show("analyzeNextMsg") }) }) observeEvent(input$toResults, updateTabsetPanel(session, "mainNav", "resultsTab") )
context("wrf_put") wrf_create(wrfinput_dir = system.file("extdata", package = "eixport"), wrfchemi_dir = file.path(tempdir()), domains = 2, frames_per_auxinput5 = 1, auxinput5_interval_m = 60, day_offset = 1, verbose = FALSE) f1 <- list.files(path = file.path(tempdir()),pattern = "wrfchemi", full.names = TRUE) CO <- wrf_get(file = f1, name = "E_CO") CO[] = 1:length(CO) wrf_put(file = f1, name = "E_CO", POL = CO) wrf_add(file = f1, name = "E_CO", POL = CO) f2 <- unzip(zipfile = paste0(system.file("extdata", package = "eixport"), "/wrfchemi_d02_2011-08-02.zip"), exdir = file.path(tempdir())) CO <- wrf_get(file = f2, name = "E_CO") CO[] = 1:length(CO) wrf_put(file = f2, name = "E_CO", POL = CO) wrf_add(file = f2, name = "E_CO", POL = CO) nc1 <- ncdf4::nc_open(f1) nc2 <- ncdf4::nc_open(f2) test_that("wrf_put works", { expect_equal(ncdf4::ncvar_get(nc1, "E_CO"), ncdf4::ncvar_get(nc2, "E_CO") ) })
hd.meantest2 <- function(y1, y2, R = 1) { z1 <- Rfast::Log(y1) z1 <- z1 - Rfast::rowmeans( z1 ) z2 <- Rfast::Log(y2) z2 <- z2 - Rfast::rowmeans( z2 ) n1 <- dim(y1)[1] ; n2 <- dim(y2)[1] ; p <- dim(y1)[2] m1 <- Rfast::colmeans(z1) m2 <- Rfast::colmeans(z2) s1 <- (n1 - 1) * Rfast::colVars(z1) s2 <- (n2 - 1) * Rfast::colVars(z2) gii <- (s1 + s2) / (n1 + n2) Mn <- (m1 - m2)^2 / gii Mn <- (n1 * n2)/(n1 + n2) * max(Mn) pvalue <- 1 - exp( -1/sqrt(pi) * exp( ( - Mn + 2 * log(p) - log( log(p) ) )/2 ) ) if ( R > 1 ) { mc <- (n1 * m1 / s1 + n2 * m2 / s2) / (n1/s1 + n2/s2) mc1 <- - m1 + mc mc2 <- - m2 + mc x1 <- Rfast::eachrow(z1, mc1, oper = "+") x2 <- Rfast::eachrow(z2, mc2, oper = "+") Mnb <- numeric(R) for (i in 1:R) { xb1 <- x1[sample(1:n1, n1, replace = TRUE), ] xb2 <- x2[sample(1:n2, n2, replace = TRUE), ] m1 <- Rfast::colmeans(xb1) m2 <- Rfast::colmeans(xb2) s1 <- (n1 - 1) * Rfast::colVars(xb1) s2 <- (n2 - 1) * Rfast::colVars(xb2) gii <- (s1 + s2) / (n1 + n2) stat <- (m1 - m2)^2 / gii Mnb[i] <- max(stat) } pvalue <- ( sum( (n1 * n2)/(n1 + n2) * Mnb >= Mn ) + 1 ) / (R + 1) } res <- c(Mn, pvalue) names(res) <- c("Mn", "p-value") res }
StackingXY <- function(YList,XList,RespDist,Beta,VT,B=NULL,ZZMatrix,LinkList) { for (i in 1:length(YList)){ if (i==1) { Y<-YList[[1]] X<-XList[[1]] } else { Y<-rbind(Y,YList[[i]]) X<-dbind(X,XList[[i]]) } } if (is.null(B)) B<-rep(1,length(Y)) nModels <- length(YList) ModelsDims <- sapply(YList,nrow) cModelsDims <- cumsum(c(0,ModelsDims)) mu<-0 Wvec<-0 dWdmu<-0 dmudeta<-0 d2Wdmu2<-0 TT <- cbind(X,ZZMatrix) nrand <- ncol(ZZMatrix) ptot <- ncol(X) ntot <- nrow(Y) TT <- rbind(TT, cbind(matrix(0,nrand,ptot),diag(nrand))) eta<-TT[1:ntot,]%*%as.matrix(c(Beta,unlist(VT))) for (i in 1:nModels){ mu[(cModelsDims[i]+1):cModelsDims[i+1]]<-B[(cModelsDims[i]+1):cModelsDims[i+1]]*InvLinkY(eta[(cModelsDims[i]+1):cModelsDims[i+1]],LinkList[[i]]) Wvec[(cModelsDims[i]+1):cModelsDims[i+1]]<-Wmatgen(mu[(cModelsDims[i]+1):cModelsDims[i+1]],B[(cModelsDims[i]+1):cModelsDims[i+1]],LinkList[[i]],RespDist[i]) dWdmu[(cModelsDims[i]+1):cModelsDims[i+1]]<-dWdmugen(mu[(cModelsDims[i]+1):cModelsDims[i+1]],B[(cModelsDims[i]+1):cModelsDims[i+1]],LinkList[[i]],RespDist[i]) d2Wdmu2[(cModelsDims[i]+1):cModelsDims[i+1]]<-d2Wdmu2gen(mu[(cModelsDims[i]+1):cModelsDims[i+1]],B[(cModelsDims[i]+1):cModelsDims[i+1]],LinkList[[i]],RespDist[i]) dmudeta[(cModelsDims[i]+1):cModelsDims[i+1]]<-dmudetagen(mu[(cModelsDims[i]+1):cModelsDims[i+1]],B[(cModelsDims[i]+1):cModelsDims[i+1]],LinkList[[i]],RespDist[i]) } return(list(TT=TT),mu=mu,Wvec=Wvec,dWdmu=dWdmu,d2Wdmu2,dmudeta=dmudeta) }
set.global <- function(K = 2, X.spmd = NULL, PARAM = NULL, algorithm = c("em", "aecm", "apecm", "apecma", "kmeans"), RndEM.iter = 10){ if(is.null(X.spmd)){ if(exists("X.spmd", envir = .pmclustEnv)){ X.spmd <- get("X.spmd", envir = .pmclustEnv) } else{ A <- exists("X.spmd", envir = .GlobalEnv) B <- exists("X.gbd", envir = .GlobalEnv) if(A){ } else if(B){ X.spmd <- get("X.gbd", envir = .pmclustEnv) .pmclustEnv$X.spmd <- X.spmd } else{ comm.stop("A global X.spmd or X.gbd does not exist.") } } } else{ .pmclustEnv$X.spmd <- X.spmd } N.spmd <- nrow(X.spmd) N.allspmds <- spmd.allgather.integer(as.integer(N.spmd), integer(spmd.comm.size())) N <- sum(N.allspmds) p <- ncol(X.spmd) if(is.null(PARAM)){ PARAM <- list(N = N, p = p, K = K, ETA = rep(1 / K, K), log.ETA = rep(-log(K), K), MU = NULL, SIGMA = rep(list(diag(1.0, p)), K), U = rep(list(), K), U.check = rep(TRUE, K), logL = NULL, min.N.CLASS = min(c((p + 1) * p * 0.5 + 1, N / K * 0.2))) } else{ PARAM$N <- N K <- PARAM$K } .pmclustEnv$CONTROL <- .PMC.CT$CONTROL .pmclustEnv$CONTROL$RndEM.iter <- RndEM.iter .pmclustEnv$COMM.SIZE <- spmd.comm.size() .pmclustEnv$COMM.RANK <- spmd.comm.rank() .pmclustEnv$p.times.logtwopi <- p * log(2 * pi) .pmclustEnv$Z.spmd <- matrix(0.0, nrow = N.spmd, ncol = K) .pmclustEnv$Z.colSums <- rep(0.0, K) .pmclustEnv$W.spmd <- matrix(0.0, nrow = N.spmd, ncol = K) .pmclustEnv$W.spmd.rowSums <- rep(0.0, N.spmd) .pmclustEnv$U.spmd <- matrix(0.0, nrow = N.spmd, ncol = K) .pmclustEnv$CLASS.spmd <- rep(0, N.spmd) .pmclustEnv$CHECK <- list(algorithm = algorithm[1], i.iter = 0, abs.err = Inf, rel.err = Inf, convergence = 0) for(i.k in 1:K){ tmp.U <- decompsigma(PARAM$SIGMA[[i.k]]) PARAM$U[[i.k]] <- tmp.U$value PARAM$U.check[[i.k]] <- tmp.U$check } PARAM }
setES <- function(MAXPROMPT=NULL, IMEI_NUMBERS=NULL, SVYNAMES=NULL, ESVN=NULL) { if(is.null(MAXPROMPT) | !is.numeric(MAXPROMPT)) { stop("Argument 'MAXPROMPT' is obligatory. It must be of type numeric.") } if(MAXPROMPT%%1 != 0L | MAXPROMPT <= 0) { stop("Argument 'MAXPROMPT' must be a positive integer.") } MAXPROMPT <- as.integer(MAXPROMPT) if(!is.vector(IMEI_NUMBERS) | !is.character(IMEI_NUMBERS)) { stop("Argument 'IMEI_NUMBERS' must be a vector containing elements of type 'character'.") } if(is.null(ESVN)) { stop("Argument 'ESVN' is missing. It must be produced by the function 'relevantESVN'.") } else if (class(ESVN) != "list" | is.integer0(ESVN[["ES_DATETIMES_SEP"]]) | !is.logical(ESVN[["ES_DATETIMES_SEP"]])) { stop("Argument 'ESVN' must be produced by the function 'relevantESVN'.") } checkIMEI_NUMBERS_len <- c() for(i in 1:length(IMEI_NUMBERS)) {checkIMEI_NUMBERS_len <- c(checkIMEI_NUMBERS_len, nchar(IMEI_NUMBERS[i]))} if(!is.vector(IMEI_NUMBERS) | var(checkIMEI_NUMBERS_len) != 0) { stop('All IMEI numbers must contain an equal amount of single characters, e.g. "3" and "47" differ by 1 single character.') } RELEVANTINFO_ES <- list() RELEVANTINFO_ES[["MAXPROMPT"]] <- MAXPROMPT RELEVANTINFO_ES[["IMEI_NUMBERS"]] <- IMEI_NUMBERS if(!is.null(SVYNAMES)) { if(!is.character(SVYNAMES)) { stop("Argument 'SVYNAMES' must be of type 'character'.") } RELEVANTINFO_ES[["SVYNAMES"]] <- SVYNAMES } else { RELEVANTINFO_ES[["SVYNAMES"]] <- "NO_SURVEY_NAMES_PASSED_BY_USER" } RELEVANTVN_ES <- list() RELEVANTVN_ES[["ES_SVY_NAME"]] <- ESVN[[1]] RELEVANTVN_ES[["ES_IMEI"]] <- ESVN[[2]] if(ESVN[["ES_DATETIMES_SEP"]]) { RELEVANTVN_ES[["ES_START_DATE"]] <- ESVN[[3]] RELEVANTVN_ES[["ES_START_TIME"]] <- ESVN[[4]] RELEVANTVN_ES[["ES_END_DATE"]] <- ESVN[[5]] RELEVANTVN_ES[["ES_END_TIME"]] <- ESVN[[6]] cat("For the event sampling dataset(s) next apply the function 'genKey' and then function 'genDateTime'.") } else { RELEVANTVN_ES[["ES_START_DATETIME"]] <- ESVN[[3]] RELEVANTVN_ES[["ES_END_DATETIME"]] <- ESVN[[4]] cat("For the event sampling dataset(s) next apply the function 'genKey' and then function 'splitDateTime'.") } list(RELEVANTVN_ES = RELEVANTVN_ES, RELEVANTINFO_ES = RELEVANTINFO_ES) }
GIN <- function(level){ x <- NULL if(level==1){ x1 <- github.cssegisanddata.covid19(country = "Guinea") x2 <- ourworldindata.org(id = "GIN") x <- full_join(x1, x2, by = "date") } return(x) }
knitr::opts_chunk$set( collapse = TRUE, comment = " out.width = "300px", fig.align = "center", dpi = 300 ) library(ggplot2) theme_set(theme_bw()) library(dplyr) library(mgcv) library(tidymv) set.seed(10) data <- gamSim(4) model <- gam( y ~ fac + s(x2) + s(x2, by = fac) + s(x0), data = data ) plot_smooths( model = model, series = x2, comparison = fac ) + theme(legend.position = "top") data("pois_df") pois_gam <- gam(y ~ s(x, by = fac), data = pois_df, family = poisson) plot_smooths(pois_gam, x, fac, transform = exp, series_length = 70) + theme(legend.position = "top") model_2 <- gam( y ~ s(x0) + s(x2), data = data ) plot_smooths( model = model_2, series = x0 ) data("inter_df") inter_df <- inter_df %>% mutate( x1x2 = interaction(x1, x2) ) model_inter <- bam( y ~ x1x2 + s(x0, k = 8, by = x1x2), data = inter_df ) plot_smooths( model = model_inter, series = x0, comparison = x1, facet_terms = x2, split = list(x1x2 = c("x1", "x2")) ) + theme(legend.position = "top") plot_smooths( model = model_inter, series = x0, comparison = x1, facet_terms = x2, conditions = quos(x2 == "b"), split = list(x1x2 = c("x1", "x2")) ) + theme(legend.position = "top") plot_smooths( model = model_inter, series = x0, comparison = x1, facet_terms = x2, conditions = quos(x1 %in% c(1, 3)), split = list(x1x2 = c("x1", "x2")) ) + theme(legend.position = "top") preds <- get_gam_predictions(model_inter, x0, split = list(x1x2 = c("x1", "x2"))) preds %>% ggplot(aes(x0, y)) + geom_ribbon(aes(ymin = CI_lower, ymax = CI_upper, fill = x1, group = .idx), alpha = 0.3) + geom_line(aes(colour = x1, linetype = x2)) plot_difference( pois_gam, series = x, difference = list(fac = c("b", "a")) ) plot_difference( model_inter, x0, difference = list(x1x2 = c("2.a", "3.a")) ) plot_difference( model_inter, x0, difference = list(x1x2 = c("1.b", "2.b")) ) inter_diff <- get_smooths_difference(model_inter, x0, list(x1x2 = c("2.a", "3.a"))) inter_diff %>% ggplot(aes(x0, difference, group = group)) + geom_hline(aes(yintercept = 0), colour = " geom_ribbon(aes(ymin = CI_lower, ymax = CI_upper, fill = sig_diff), alpha = 0.3) + geom_line(aes(colour = sig_diff), size = 1) + scale_colour_manual(values = c(" scale_fill_manual(values = c(" labs(colour = "significant", fill = "significant") + theme(legend.position = "top") set.seed(10) data <- gamSim(4) fac_gam <- gam(y ~ fac + s(x2) + s(x2, by = fac) + s(x0), data = data) fac_diff <- get_smooths_difference(model, x2, list(fac = c("1", "2"))) fac_diff %>% ggplot(aes(x2, difference)) + geom_hline(aes(yintercept = 0)) + geom_ribbon(aes(ymin = -Inf, ymax = Inf, fill = sig_diff, group = group), alpha = 0.2) + geom_ribbon(aes(ymin = CI_lower, ymax = CI_upper), alpha = 0.3) + geom_line(size = 1) + labs(colour = "significant", fill = "significant") + theme(legend.position = "top")
context("Encoding Tests") test_that("Write read encoding equality", { tempFile <- file.path(tempdir(), "temp.xlsx") wb <- createWorkbook() for(i in 1:4) addWorksheet(wb, sprintf('Sheet %s', i)) df <- data.frame("X" = c("测试", "一下"), stringsAsFactors = FALSE) writeDataTable(wb, sheet = 1, x = df) saveWorkbook(wb, tempFile, overwrite = TRUE) x <- read.xlsx(tempFile) expect_equal(x, df) x <- read.xlsx(wb) expect_equal(x, df) wb <- loadWorkbook(tempFile) x <- read.xlsx(wb) expect_equal(x, df) saveWorkbook(wb, tempFile, overwrite = TRUE) x <- read.xlsx(tempFile) expect_equal(x, df) unlink(tempFile, recursive = TRUE, force = TRUE) rm(wb) })
context("result-parsers") raw_rec <- entrez_fetch(db="pubmed", id=20674752, rettype="xml") xml_rec <- entrez_fetch(db="pubmed", id=20674752, rettype="xml", parsed=TRUE) multi_rec <- entrez_fetch(db="pubmed", id=c(22883857, 25042335, 20203609,11959827), rettype="xml", parsed=TRUE) parsed_raw <- parse_pubmed_xml(raw_rec) parsed_rec <- parse_pubmed_xml(xml_rec) parsed_multi <- parse_pubmed_xml(multi_rec) multi_pmid_eg <- parse_pubmed_xml( entrez_fetch(db="pubmed", id='29743284', rettype="xml") ) test_that("pubmed file parsers work",{ expect_that(raw_rec, is_a("character")) expect_that(parsed_raw, is_a("pubmed_record")) expect_that(parsed_rec, is_a("pubmed_record")) expect_that(names(parsed_rec), is_a("character")) expect_that(parsed_rec$pmid, is_identical_to("20674752")) expect_that(parsed_multi, is_a("multi_pubmed_record")) expect_that(parsed_multi[[1]], is_a("pubmed_record")) expect_that(length(parsed_multi), equals(4)) expect_that(length(parsed_multi[[1]]$authors), equals(1)) expect_that(length(multi_pmid_eg$pmid), equals(1)) }) test_that("we can print pubmed records", { expect_output(print(parsed_rec), "Pubmed record") expect_output(print(parsed_multi), "List of 4 pubmed records") }) test_that("We warn about unknown pubmed record types", { rec = entrez_fetch(db="pubmed", id=25905152, rettype="xml") expect_warning(parsed_rec <- parse_pubmed_xml(rec)) expect_output(print(parsed_rec), "Pubmed record \\(empty\\)") })
repr_dwt <- function(x, level = 4, filter = "d4") { x <- as.numeric(x) repr <- wavelets::dwt(x, filter = filter, n.levels = level, boundary = "periodic")@V[[level]] return(as.vector(repr)) } repr_dft <- function(x, coef = 10) { x <- as.numeric(x) fourier_fft <- fft(x) inv_fft <- fft(fourier_fft[1:coef], inverse = TRUE) / coef return(as.vector(Re(inv_fft))) } repr_dct <- function(x, coef = 10) { x <- as.numeric(x) x_dct <- dtt::dct(x) repr <- dtt::dct(x_dct[1:coef], inverted = TRUE) return(as.vector(repr)) }
knitr::opts_chunk$set( collapse = TRUE, comment = " ) library(ondisc) raw_data_dir <- system.file("extdata", package = "ondisc") list.files(raw_data_dir) mtx_fp <- paste0(raw_data_dir, "/gene_expression.mtx") barcodes_fp <- paste0(raw_data_dir, "/cell_barcodes.tsv") features_fp <- paste0(raw_data_dir, "/genes.tsv") temp_dir <- tempdir() exp_mat_list <- create_ondisc_matrix_from_mtx(mtx_fp = mtx_fp, barcodes_fp = barcodes_fp, features_fp = features_fp, on_disk_dir = temp_dir) expression_mat <- exp_mat_list$ondisc_matrix head(expression_mat) cell_covariates <- exp_mat_list$cell_covariates head(cell_covariates) feature_covariates <- exp_mat_list$feature_covariates head(feature_covariates) "ondisc_matrix_1.h5" %in% list.files(temp_dir) feature_ids <- get_feature_ids(expression_mat) feature_names <- get_feature_names(expression_mat) cell_barcodes <- get_cell_barcodes(expression_mat) head(feature_ids) head(feature_names) head(cell_barcodes) dim(expression_mat) nrow(expression_mat) ncol(expression_mat) x <- expression_mat[100:110,] x <- expression_mat[,-c(10,20)] x <- expression_mat[c(50:100, 200:250), 300:500] x <- expression_mat[c("ENSG00000107581", "ENSG00000286857", "ENSG00000266371"),] x <- expression_mat[,c("CGTTGGGCATGGCTGC-1", "GTAACCAGTACAGTTC-1")] x <- expression_mat[!(get_feature_ids(expression_mat) %in% c("ENSG00000237832", "ENSG00000229637")),] expression_mat m <- expression_mat[[6,]] m <- expression_mat[[,200:250]] m <- expression_mat[[50:100, 200:250]] m <- expression_mat[[c("ENSG00000107581", "ENSG00000286857"),]] m <- expression_mat[[,c("CGTTGGGCATGGCTGC-1", "GTAACCAGTACAGTTC-1")]] x <- expression_mat[c("ENSG00000107581", "ENSG00000286857", "ENSG00000266371"),] m <- x[[get_feature_ids(x) != "ENSG00000107581",]] saveRDS(object = expression_mat, file = paste0(temp_dir, "/expression_matrix.rds")) rm(expression_mat) expression_mat <- readRDS(paste0(temp_dir, "/expression_matrix.rds")) h5_file <- paste0(temp_dir, "/ondisc_matrix_1.h5") expression_mat <- ondisc_matrix(h5_file)
"fun.simu.bimodal" <- function(result1, result2, prop1, prop2, len=1000,no.test = 1000, param1, param2) { if (missing(prop2)) { prop2 <- 1 - prop1 } no.1 <- round(len * no.test * prop1) sample.fitted1 <- rgl(no.1, result1[1], result1[2], result1[3], result1[4], param1) sample.fitted2 <- rgl(len * no.test - no.1, result2[1], result2[2], result2[3], result2[4], param2) sample.fitted <- split(c(sample.fitted1, sample.fitted2), 1:no.test) return(sample.fitted) }
species.richness.main <- function(dataset.all.species, dataset.landwater, dataset.height, distances=1:10, weight=0.5, resolution=1, narrow.endemic=FALSE, narrow.endemic.limit=5, upperbound=5, cross.validation=FALSE, fold=5, loocv.limit=10, create.image=FALSE, image.title="Interpolated Species Richness", directory=getwd(), filename="species.richness.png", evaluation=FALSE, eval.title="Histogramm", adjust=FALSE, clusterlimit=100, predefinedClusterlist=NULL, all.species=-1, export=FALSE, drivername="GTiff", exportname="species.richness.tif", noninterpolatedgrid=NULL, silent=TRUE, do.parallel=FALSE){ if (!silent) cat("Preparing grid.. ") dimension <- getDimension(dataset.all.species, resolution) shift <- getShift(dataset.all.species) if (!silent) cat("Done!\n") if (!silent) cat("Preparing land-water-mask.. ") landwatermask <- createLandwatermask(dataset.landwater, dimension, shift, resolution) if (!silent) cat("Done!\n") if (!silent) cat("Preparing height-information.. ") height.matrix <- createHeightmask(dataset.height, dimension, shift, resolution) if (!silent) cat("Done!\n") height.matrix[which(height.matrix < 0)] <- 0 landwatermask[which(landwatermask >= 0)] <- height.matrix[which(landwatermask >= 0)] if (narrow.endemic){ if (!silent) cat("Extracting narrow endemic species.. ",sep="") all.species <- getNarrowEndemics(dataset.all.species, all.species, narrow.endemic.limit, dimension, shift, resolution) if (!silent) cat("Done!\n") } if (cross.validation){ if (!silent) cat("Calculating cross-validated species richness.. \n") species.richness.weighted <- species.richness.cv(dataset.all.species, landwatermask, fold, loocv.limit, distances, weight, dimension, shift, resolution, upperbound, all.species, silent, do.parallel) } else { if (!silent) cat("Calculating species richness.. \n") species.richness.weighted <- species.richness(dataset.all.species, landwatermask, distances, weight, dimension, shift, resolution, upperbound, all.species, silent, do.parallel) } if (adjust){ if (!silent) cat("Adjusting grid .. ") if (is.null(noninterpolatedgrid)){ noninterpolatedgrid <- createNonInterpolatedGrid(dataset.all.species, dimension, shift, resolution, all.species) } if (is.null(predefinedClusterlist)){ clusterlist <- searchClusters(species.richness.weighted, dimension, shift, resolution=1, clusterlimit) } else { clusterlist <- predefinedClusterlist } species.richness.weighted <- adjustment(species.richness.weighted, noninterpolatedgrid, clusterlist) if (!silent) cat("Done!\n") } if (create.image){ if (!silent) cat("Creating Map (PNG-File).. ") if(createImage(species.richness.weighted, landwatermask, image.title, directory, filename, shift, parts=10, resolution)){ if (!silent) cat("PNG-File successfully created!\n") } else { cat("PNG-File-Creation failed!\n") } } if (evaluation) { if (!silent) cat("Creating Evaluation (PNG-File).. ") if(evaluate(result.grid.one=species.richness.weighted, result.grid.two=NULL, title.one=eval.title, title.two=NULL, xmax=400, directory=directory, filename=paste(substring(filename, 1, nchar(filename)-4),".histogramm.png",sep=""))){ if (!silent) cat("PNG-File successfully created!\n") } else { if (!silent) cat("PNG-File-Creation failed!\n") } } if (export) { if (!silent) cat("Export .. ") exportAsGDAL(species.richness.weighted, shift, resolution, directory=directory, filename=exportname, drivername=drivername) if (!silent) cat("Done!\n") } return(species.richness.weighted) }
library(checkargs) context("isNegativeNumberOrNaOrNanVectorOrNull") test_that("isNegativeNumberOrNaOrNanVectorOrNull works for all arguments", { expect_identical(isNegativeNumberOrNaOrNanVectorOrNull(NULL, stopIfNot = FALSE, message = NULL, argumentName = NULL), TRUE) expect_identical(isNegativeNumberOrNaOrNanVectorOrNull(TRUE, stopIfNot = FALSE, message = NULL, argumentName = NULL), FALSE) expect_identical(isNegativeNumberOrNaOrNanVectorOrNull(FALSE, stopIfNot = FALSE, message = NULL, argumentName = NULL), FALSE) expect_identical(isNegativeNumberOrNaOrNanVectorOrNull(NA, stopIfNot = FALSE, message = NULL, argumentName = NULL), TRUE) expect_identical(isNegativeNumberOrNaOrNanVectorOrNull(0, stopIfNot = FALSE, message = NULL, argumentName = NULL), TRUE) expect_identical(isNegativeNumberOrNaOrNanVectorOrNull(-1, stopIfNot = FALSE, message = NULL, argumentName = NULL), TRUE) expect_identical(isNegativeNumberOrNaOrNanVectorOrNull(-0.1, stopIfNot = FALSE, message = NULL, argumentName = NULL), TRUE) expect_identical(isNegativeNumberOrNaOrNanVectorOrNull(0.1, stopIfNot = FALSE, message = NULL, argumentName = NULL), FALSE) expect_identical(isNegativeNumberOrNaOrNanVectorOrNull(1, stopIfNot = FALSE, message = NULL, argumentName = NULL), FALSE) expect_identical(isNegativeNumberOrNaOrNanVectorOrNull(NaN, stopIfNot = FALSE, message = NULL, argumentName = NULL), TRUE) expect_identical(isNegativeNumberOrNaOrNanVectorOrNull(-Inf, stopIfNot = FALSE, message = NULL, argumentName = NULL), FALSE) expect_identical(isNegativeNumberOrNaOrNanVectorOrNull(Inf, stopIfNot = FALSE, message = NULL, argumentName = NULL), FALSE) expect_identical(isNegativeNumberOrNaOrNanVectorOrNull("", stopIfNot = FALSE, message = NULL, argumentName = NULL), FALSE) expect_identical(isNegativeNumberOrNaOrNanVectorOrNull("X", stopIfNot = FALSE, message = NULL, argumentName = NULL), FALSE) expect_identical(isNegativeNumberOrNaOrNanVectorOrNull(c(TRUE, FALSE), stopIfNot = FALSE, message = NULL, argumentName = NULL), FALSE) expect_identical(isNegativeNumberOrNaOrNanVectorOrNull(c(FALSE, TRUE), stopIfNot = FALSE, message = NULL, argumentName = NULL), FALSE) expect_identical(isNegativeNumberOrNaOrNanVectorOrNull(c(NA, NA), stopIfNot = FALSE, message = NULL, argumentName = NULL), TRUE) expect_identical(isNegativeNumberOrNaOrNanVectorOrNull(c(0, 0), stopIfNot = FALSE, message = NULL, argumentName = NULL), TRUE) expect_identical(isNegativeNumberOrNaOrNanVectorOrNull(c(-1, -2), stopIfNot = FALSE, message = NULL, argumentName = NULL), TRUE) expect_identical(isNegativeNumberOrNaOrNanVectorOrNull(c(-0.1, -0.2), stopIfNot = FALSE, message = NULL, argumentName = NULL), TRUE) expect_identical(isNegativeNumberOrNaOrNanVectorOrNull(c(0.1, 0.2), stopIfNot = FALSE, message = NULL, argumentName = NULL), FALSE) expect_identical(isNegativeNumberOrNaOrNanVectorOrNull(c(1, 2), stopIfNot = FALSE, message = NULL, argumentName = NULL), FALSE) expect_identical(isNegativeNumberOrNaOrNanVectorOrNull(c(NaN, NaN), stopIfNot = FALSE, message = NULL, argumentName = NULL), TRUE) expect_identical(isNegativeNumberOrNaOrNanVectorOrNull(c(-Inf, -Inf), stopIfNot = FALSE, message = NULL, argumentName = NULL), FALSE) expect_identical(isNegativeNumberOrNaOrNanVectorOrNull(c(Inf, Inf), stopIfNot = FALSE, message = NULL, argumentName = NULL), FALSE) expect_identical(isNegativeNumberOrNaOrNanVectorOrNull(c("", "X"), stopIfNot = FALSE, message = NULL, argumentName = NULL), FALSE) expect_identical(isNegativeNumberOrNaOrNanVectorOrNull(c("X", "Y"), stopIfNot = FALSE, message = NULL, argumentName = NULL), FALSE) expect_identical(isNegativeNumberOrNaOrNanVectorOrNull(NULL, stopIfNot = TRUE, message = NULL, argumentName = NULL), TRUE) expect_error(isNegativeNumberOrNaOrNanVectorOrNull(TRUE, stopIfNot = TRUE, message = NULL, argumentName = NULL)) expect_error(isNegativeNumberOrNaOrNanVectorOrNull(FALSE, stopIfNot = TRUE, message = NULL, argumentName = NULL)) expect_identical(isNegativeNumberOrNaOrNanVectorOrNull(NA, stopIfNot = TRUE, message = NULL, argumentName = NULL), TRUE) expect_identical(isNegativeNumberOrNaOrNanVectorOrNull(0, stopIfNot = TRUE, message = NULL, argumentName = NULL), TRUE) expect_identical(isNegativeNumberOrNaOrNanVectorOrNull(-1, stopIfNot = TRUE, message = NULL, argumentName = NULL), TRUE) expect_identical(isNegativeNumberOrNaOrNanVectorOrNull(-0.1, stopIfNot = TRUE, message = NULL, argumentName = NULL), TRUE) expect_error(isNegativeNumberOrNaOrNanVectorOrNull(0.1, stopIfNot = TRUE, message = NULL, argumentName = NULL)) expect_error(isNegativeNumberOrNaOrNanVectorOrNull(1, stopIfNot = TRUE, message = NULL, argumentName = NULL)) expect_identical(isNegativeNumberOrNaOrNanVectorOrNull(NaN, stopIfNot = TRUE, message = NULL, argumentName = NULL), TRUE) expect_error(isNegativeNumberOrNaOrNanVectorOrNull(-Inf, stopIfNot = TRUE, message = NULL, argumentName = NULL)) expect_error(isNegativeNumberOrNaOrNanVectorOrNull(Inf, stopIfNot = TRUE, message = NULL, argumentName = NULL)) expect_error(isNegativeNumberOrNaOrNanVectorOrNull("", stopIfNot = TRUE, message = NULL, argumentName = NULL)) expect_error(isNegativeNumberOrNaOrNanVectorOrNull("X", stopIfNot = TRUE, message = NULL, argumentName = NULL)) expect_error(isNegativeNumberOrNaOrNanVectorOrNull(c(TRUE, FALSE), stopIfNot = TRUE, message = NULL, argumentName = NULL)) expect_error(isNegativeNumberOrNaOrNanVectorOrNull(c(FALSE, TRUE), stopIfNot = TRUE, message = NULL, argumentName = NULL)) expect_identical(isNegativeNumberOrNaOrNanVectorOrNull(c(NA, NA), stopIfNot = TRUE, message = NULL, argumentName = NULL), TRUE) expect_identical(isNegativeNumberOrNaOrNanVectorOrNull(c(0, 0), stopIfNot = TRUE, message = NULL, argumentName = NULL), TRUE) expect_identical(isNegativeNumberOrNaOrNanVectorOrNull(c(-1, -2), stopIfNot = TRUE, message = NULL, argumentName = NULL), TRUE) expect_identical(isNegativeNumberOrNaOrNanVectorOrNull(c(-0.1, -0.2), stopIfNot = TRUE, message = NULL, argumentName = NULL), TRUE) expect_error(isNegativeNumberOrNaOrNanVectorOrNull(c(0.1, 0.2), stopIfNot = TRUE, message = NULL, argumentName = NULL)) expect_error(isNegativeNumberOrNaOrNanVectorOrNull(c(1, 2), stopIfNot = TRUE, message = NULL, argumentName = NULL)) expect_identical(isNegativeNumberOrNaOrNanVectorOrNull(c(NaN, NaN), stopIfNot = TRUE, message = NULL, argumentName = NULL), TRUE) expect_error(isNegativeNumberOrNaOrNanVectorOrNull(c(-Inf, -Inf), stopIfNot = TRUE, message = NULL, argumentName = NULL)) expect_error(isNegativeNumberOrNaOrNanVectorOrNull(c(Inf, Inf), stopIfNot = TRUE, message = NULL, argumentName = NULL)) expect_error(isNegativeNumberOrNaOrNanVectorOrNull(c("", "X"), stopIfNot = TRUE, message = NULL, argumentName = NULL)) expect_error(isNegativeNumberOrNaOrNanVectorOrNull(c("X", "Y"), stopIfNot = TRUE, message = NULL, argumentName = NULL)) })
emuDBhandle = function(dbName, basePath, UUID, connectionPath, connection = NULL){ if(is.null(connection)){ con <- DBI::dbConnect(RSQLite::SQLite(), connectionPath) }else{ con = connection } handle = list(dbName = dbName, basePath = basePath, UUID = UUID, connection = con) class(handle) = "emuDBhandle" if(class(handle$connection) == "SQLiteConnection"){ setSQLitePragmas(handle$connection) RSQLite::initRegExp(handle$connection) } if(connectionPath == ":memory:" || file.exists(file.path(basePath, paste0(dbName, database.cache.suffix))) || !is.null(connection)){ initialize_emuDbDBI(handle) } return(handle) } setSQLitePragmas <- function(con){ DBI::dbExecute(con, "PRAGMA foreign_keys = ON;") DBI::dbExecute(con, "PRAGMA temp_store = 2;") } print.emuDBhandle = function(x, ...){ check_emuDBhandle(x) print(paste0("<emuDBhandle> (dbName = '", x$dbName, "', basePath = '", x$basePath, "')")) } check_emuDBhandle <- function(emuDBhandle, checkCache = TRUE){ if(!dir.exists(emuDBhandle$basePath)){ stop(paste0("emuDBhandle is invalid as emuDBhandle$basePath ", "doesn't exist! Please reload the emuDB.")) } if(!DBI::dbIsValid(emuDBhandle$connection)){ stop(paste0("emuDBhandle is invalid as emuDBhandle$connection is not ", "a valid DBI connection! Please reload the emuDB.")) } dbName = stringr::str_replace(basename(emuDBhandle$basePath), pattern = '_emuDB$', replacement = '') if(!file.exists(file.path(emuDBhandle$basePath, paste0(dbName, database.schema.suffix)))){ stop(paste0("emuDBhandle is invalid as the directory emuDBhandle$basePath doesn't ", "contain the _DBconfig.json file '", dbName, "_DBconfig.json'. Note that ", "the emuDB directory has to have the same prefix / name as the _DBconfig.json.")) } if(checkCache){ if(!file.exists(file.path(emuDBhandle$basePath, paste0(dbName, database.cache.suffix)))){ stop(paste0("emuDBhandle is invalid as the directory emuDBhandle$basePath doesn't contain ", "a _emuDBcache.sqlite file! Please reload the emuDB to recreate the emuDBcache.")) } } } summary.emuDBhandle = function(object, ...){ check_emuDBhandle(object) cli::cli_h1("Summary of emuDB") cat("Name:\t", object$dbName, "\n") cat("UUID:\t", object$UUID, "\n") cat("Directory:\t", object$basePath, "\n") sess = list_sessions(object) cat("Session count:", nrow(sess), "\n") bndls = list_bundles(object) cat("Bundle count:", nrow(bndls), "\n") itCntQ = paste0("SELECT count(*) FROM items WHERE db_uuid='", object$UUID, "'") itCntDf = DBI::dbGetQuery(object$connection, itCntQ) itemCnt = itCntDf[[1]] labCntQ = paste0("SELECT count(*) FROM labels WHERE db_uuid='", object$UUID, "'") labCntDf = DBI::dbGetQuery(object$connection, labCntQ) labCnt = labCntDf[[1]] liCntQ = paste0("SELECT count(*) FROM links WHERE db_uuid='", object$UUID, "'") liCntDf = DBI::dbGetQuery(object$connection, liCntQ) linkCnt = liCntDf[[1]] cat("Annotation item count: ", itemCnt, "\n") cat("Label count: ", labCnt, "\n") cat("Link count: ", linkCnt, "\n") cli::cli_h1("Database configuration") dbConfig = load_DBconfig(object) cli::cli_h2("SSFF track definitions") ssffTrackDefs = list_ssffTrackDefinitions(object) pr <- print.data.frame(ssffTrackDefs, right = FALSE, row.names = FALSE) cat("\n") cli::cli_h2("Level definitions") levelDefs = list_levelDefinitions(object) pr <- print.data.frame(levelDefs, right = FALSE, row.names = FALSE) cat("\n") lblGrps = list_labelGroups(object) if(nrow(lblGrps) > 0){ cli::cli_h2("Database label group definitions") pr <- print.data.frame(lblGrps, right = FALSE, row.names = FALSE) cat("\n") } cli::cli_h2("Link definitions") linkDefs = list_linkDefinitions(object) pr <- print.data.frame(linkDefs, right = FALSE, row.names = FALSE) }
NULL data.table = maditr::data.table as.data.table = maditr::as.data.table setkeyv = maditr::setkeyv htmlTable::htmlTable htmlTable::htmlTableWidget htmlTable::htmlTableWidgetOutput htmlTable::interactiveTable .onAttach = function(...) { rnd = runif(1) if(rnd<0.2){ packageStartupMessage("\nUse 'expss_output_viewer()' to display tables in the RStudio Viewer.\n To return to the console output, use 'expss_output_default()'.\n") } if(rnd>0.8){ packageStartupMessage("\nUse 'expss_output_rnotebook()' to display tables inside R Notebooks.\n To return to the console output, use 'expss_output_default()'.\n") } }
dotTree<-function(tree,x,legend=TRUE,method="plotTree",standardize=FALSE,...){ if(is.data.frame(x)) x<-as.matrix(x) if(hasArg(data.type)) data.type<-list(...)$data.type else { if(is.numeric(x)) data.type<-"continuous" else data.type<-"discrete" } if(data.type=="continuous"){ if(hasArg(colors)) colors<-list(...)$colors else colors<-"blue" dotTree.continuous(tree,x,colors[1],legend,method,standardize,...) } else if(data.type=="discrete"){ if(hasArg(colors)) colors<-list(...)$colors else { ss<-unique(as.vector(x)) colors<-setNames(palette()[1:length(ss)],ss) } dotTree.discrete(tree,x,colors,legend,method,...) } } dotTree.continuous<-function(tree,x,color,legend,method,standardize,...){ if(is.data.frame(x)) x<-as.matrix(x) if(is.matrix(x)&&method=="plotTree"){ if(ncol(x)>1) method<-"phylogram" else x<-x[,1] } if(hasArg(fsize)) fsize<-list(...)$fsize else fsize<-c(1,0.8) if(length(fsize)==1) fsize<-rep(fsize,2) if(hasArg(x.space)) x.space<-list(...)$x.space else x.space<-0.1 if(hasArg(k)) k<-list(...)$k else k<-0.8 tree<-reorder(tree,"cladewise") if(standardize){ if(is.matrix(x)){ sd<-apply(x,2,function(x) sqrt(var(x))) x<-(x-matrix(rep(1,Ntip(tree)),Ntip(tree),1)%*%colMeans(x))/ (matrix(rep(1,Ntip(tree)),Ntip(tree),1)%*%sd) } else if(is.vector(x)) x<-(x-mean(x))/sqrt(var(x)) } min.x<-min(x) max.x<-max(x) if(any(x<0)) x<-x-min(x) if(method=="plotTree"){ fsize<-fsize[1] x<-x[tree$tip.label] plotTree(tree,offset=1.7,ylim=c(-Ntip(tree)/25, Ntip(tree)),...) obj<-get("last_plot.phylo",envir=.PlotPhyloEnv) x.tip<-obj$xx[1:obj$Ntip] y.tip<-obj$yy[1:obj$Ntip] rr<-(k*x/max(x)+x.space)/2*diff(par()$usr[1:2])/ diff(par()$usr[3:4]) if(k<=0.8&&any(rr>(strwidth("W")*fsize/2))) rr<-rr/max(rr)*strwidth("W")*fsize/2 nulo<-mapply(draw.circle,x=x.tip+1.2*strwidth("W"),y=y.tip, radius=rr,MoreArgs=list(nv=200,col=color)) if(legend){ h<-dot.legend(x=par()$usr[1]+0.1*max(nodeHeights(tree)), y=0,min.x,max.x,Ntip=Ntip(tree), method="plotTree",...) if(standardize) text(h,0.1*(1+par()$usr[3]),"(SD units)",pos=4) } } else if(method=="phylogram"){ if(is.vector(x)) x<-as.matrix(x) x[]<-x[tree$tip.label,] if(hasArg(mar)) mar<-list(...)$mar else mar<-rep(0.1,4) if(hasArg(xlim)) xlim<-list(...)$xlim else xlim<-c(-0.5,0.55+x.space*ncol(x)+x.space/2) if(hasArg(labels)) labels<-list(...)$labels else labels<-FALSE if(hasArg(ylim)) ylim<-list(...)$ylim else ylim<-c(if(legend) -0.1 else 0,if(labels) 1.1 else 1) plot.new() par(mar=mar) plot.window(xlim=xlim,ylim=ylim) h<-phylogram(tree,...) obj<-get("last_plot.phylo",envir=.PlotPhyloEnv) x.tip<-rep(h,obj$Ntip) y.tip<-obj$yy[1:obj$Ntip] rr<-(k*x/max(x)+x.space)/2*diff(par()$usr[1:2])/diff(par()$usr[3:4])/ (Ntip(tree)-1) if(k<=0.8&&any(rr>(strwidth("W")*fsize[1]/2))) rr<-rr/max(rr)*strwidth("W")*fsize[1]/2 for(i in 1:ncol(x)){ nulo<-mapply(draw.circle,x=x.tip+1.2*strwidth("W")+x.space*(i-1), y=y.tip,radius=rr[,i],MoreArgs=list(nv=200,col=color)) } if(legend){ h<-dot.legend(x=-0.45,y=-0.04,min.x,max.x,Ntip=Ntip(tree), method="phylogram",...) if(standardize) text(h,-0.04,"(SD units)",pos=4) } if(labels){ text(x=seq(max(x.tip)+1.2*strwidth("W"), max(x.tip)+1.2*strwidth("W")+x.space*(ncol(x)-1),by=x.space), y=rep(1.02,ncol(x)),colnames(x),srt=70,adj=c(0,0.5),cex=fsize[2]) } } } dotTree.discrete<-function(tree,x,color,legend,method,...){ if(is.data.frame(x)) x<-as.matrix(x) if(is.matrix(x)&&method=="plotTree"){ if(ncol(x)>1) method<-"phylogram" else x<-x[,1] } if(hasArg(fsize)) fsize<-list(...)$fsize else fsize<-c(1,0.8) if(length(fsize)==1) fsize<-rep(fsize,2) if(hasArg(x.space)) x.space<-list(...)$x.space else x.space<-0.1 tree<-reorder(tree,"cladewise") if(method=="plotTree"){ x<-x[tree$tip.label] plotTree(tree,offset=1.7,ylim=c(-1/25*Ntip(tree), Ntip(tree)),...) obj<-get("last_plot.phylo",envir=.PlotPhyloEnv) x.tip<-obj$xx[1:obj$Ntip] y.tip<-obj$yy[1:obj$Ntip] r<-min(0.8/2*diff(par()$usr[1:2])/diff(par()$usr[3:4]), strwidth("W")*fsize/2) nulo<-mapply(draw.circle,x=x.tip+1.2*strwidth("W"),y=y.tip, col=color[as.character(x)],MoreArgs=list(nv=200,radius=r)) if(legend){ add.simmap.legend(colors=color,prompt=FALSE, vertical=FALSE,shape="circle", x=par()$usr[1]+0.1*max(nodeHeights(tree)), y=-1/25*Ntip(tree)) } } else if(method=="phylogram"){ if(is.vector(x)) x<-as.matrix(x) x[]<-x[tree$tip.label,] if(hasArg(mar)) mar<-list(...)$mar else mar<-rep(0.1,4) if(hasArg(xlim)) xlim<-list(...)$xlim else xlim<-c(-0.5,0.55+x.space*ncol(x)+x.space/2) if(hasArg(labels)) labels<-list(...)$labels else labels<-FALSE if(hasArg(ylim)) ylim<-list(...)$ylim else ylim<-c(if(legend) -0.1 else 0,if(labels) 1.1 else 1) plot.new() par(mar=mar) plot.window(xlim=xlim,ylim=ylim) h<-phylogram(tree,...) obj<-get("last_plot.phylo",envir=.PlotPhyloEnv) x.tip<-rep(h,obj$Ntip) y.tip<-obj$yy[1:obj$Ntip] r<-min(0.8/2*diff(par()$usr[1:2])/diff(par()$usr[3:4])/(Ntip(tree)-1), strwidth("W")*fsize/2) for(i in 1:ncol(x)){ nulo<-mapply(draw.circle,x=x.tip+1.2*strwidth("W")+x.space*(i-1), y=y.tip,col=color[as.character(x[,i])],MoreArgs=list(nv=20, radius=r)) } if(legend){ add.simmap.legend(colors=color,prompt=FALSE, vertical=FALSE,shape="circle",x=-0.45,y=-0.06) } if(labels){ text(x=seq(max(x.tip)+1.2*strwidth("W"), max(x.tip)+1.2*strwidth("W")+x.space*(ncol(x)-1),by=x.space), y=rep(1.02,ncol(x)),colnames(x),srt=70,adj=c(0,0.5),cex=fsize[2]) } } } dot.legend<-function(x,y,min,max,Ntip,length=5,prompt=FALSE, method="plotTree",...){ if(hasArg(cex)) cex<-list(...)$cex else cex<-1 if(hasArg(fsize)) fsize<-list(...)$fsize else fsize<-1 if(hasArg(colors)) colors<-list(...)$colors else colors<-"blue" if(hasArg(leg.space)) leg.space<-list(...)$leg.space else leg.space<-0.2 if(hasArg(k)) k<-list(...)$k else k<-0.8 if(prompt){ obj<-locator(1) x<-obj$x y<-obj$y } if(method=="plotTree"){ text(x,y-0.5*(Ntip/25),round(min,2),pos=1,cex=cex) s<-(k*max(min,0)/min(max,max+min)+0.1)/2*diff(par()$usr[1:2])/ diff(par()$usr[3:4]) e<-(k+0.1)/2*diff(par()$usr[1:2])/diff(par()$usr[3:4]) rr<-seq(s,e,length.out=length) if(k<=0.8&&any(rr>(strwidth("W")*fsize/2))) rr<-rr/max(rr)*strwidth("W")*fsize/2 temp<-c(0,cumsum((1+leg.space)*rep(2*max(rr),length-1))) nulo<-mapply(draw.circle,x=x+temp,y=rep(y,length),radius=rr, MoreArgs=list(nv=200,col=colors)) text(max(x+temp),y-0.5*(Ntip/25),round(max,2),pos=1,cex=cex) y1<-0.1/25*Ntip lines(c(x,max(x+temp)),rep(y-0.5*(Ntip/25)-y1,2)) lines(c(x,x),y-c(y1+0.5*(Ntip/25),2*y1+0.5*(Ntip/25))) lines(c(max(x+temp),max(x+temp)),y-c(y1+0.5*(Ntip/25),2*y1+0.5*(Ntip/25))) } else if(method=="phylogram"){ text(x,y-0.04,round(min,2),pos=1,cex=cex) s<-(k*max(min,0)/(min(max,max+min))+0.1)/2* diff(par()$usr[1:2])/diff(par()$usr[3:4])/(Ntip-1) e<-(k+0.1)/2*diff(par()$usr[1:2])/diff(par()$usr[3:4])/(Ntip-1) rr<-seq(s,e,length.out=length) if(k<=0.8&&any(rr>(strwidth("W")*fsize/2))) rr<-rr/max(rr)*strwidth("W")*fsize/2 temp<-c(0,cumsum((1+leg.space)*rep(2*max(rr),length-1))) nulo<-mapply(draw.circle,x=x+temp,y=rep(y,length),radius=rr, MoreArgs=list(nv=200,col=colors)) text(max(x+temp),y-0.04,round(max,2),pos=1,cex=cex) y1<-0.01 lines(c(x,max(x+temp)),rep(y-0.02-y1,2)) lines(c(x,x),y-c(y1+0.02,2*y1+0.02)) lines(c(max(x+temp),max(x+temp)),y-c(y1+0.02,2*y1+0.02)) } invisible(max(x+temp)+0.5*max(rr)) }
genCheckMD5<-function(path.file,oficial.md5,verbose=FALSE,...){ file.md5<-md5sum(path.file) file.md5<-toupper(file.md5) if(file.md5==oficial.md5){ if(verbose){ message(paste0("File md5:",file.md5)) message(paste0("Oficial md5:",oficial.md5)) message("Return TRUE") } return(TRUE) }else{ if(verbose){ message(paste0("File md5:",file.md5)) message(paste0("Oficial md5:",oficial.md5)) message("Return FALSE") } return(FALSE) } }
NULL secretsmanager_cancel_rotate_secret <- function(SecretId) { op <- new_operation( name = "CancelRotateSecret", http_method = "POST", http_path = "/", paginator = list() ) input <- .secretsmanager$cancel_rotate_secret_input(SecretId = SecretId) output <- .secretsmanager$cancel_rotate_secret_output() config <- get_config() svc <- .secretsmanager$service(config) request <- new_request(svc, op, input, output) response <- send_request(request) return(response) } .secretsmanager$operations$cancel_rotate_secret <- secretsmanager_cancel_rotate_secret secretsmanager_create_secret <- function(Name, ClientRequestToken = NULL, Description = NULL, KmsKeyId = NULL, SecretBinary = NULL, SecretString = NULL, Tags = NULL) { op <- new_operation( name = "CreateSecret", http_method = "POST", http_path = "/", paginator = list() ) input <- .secretsmanager$create_secret_input(Name = Name, ClientRequestToken = ClientRequestToken, Description = Description, KmsKeyId = KmsKeyId, SecretBinary = SecretBinary, SecretString = SecretString, Tags = Tags) output <- .secretsmanager$create_secret_output() config <- get_config() svc <- .secretsmanager$service(config) request <- new_request(svc, op, input, output) response <- send_request(request) return(response) } .secretsmanager$operations$create_secret <- secretsmanager_create_secret secretsmanager_delete_resource_policy <- function(SecretId) { op <- new_operation( name = "DeleteResourcePolicy", http_method = "POST", http_path = "/", paginator = list() ) input <- .secretsmanager$delete_resource_policy_input(SecretId = SecretId) output <- .secretsmanager$delete_resource_policy_output() config <- get_config() svc <- .secretsmanager$service(config) request <- new_request(svc, op, input, output) response <- send_request(request) return(response) } .secretsmanager$operations$delete_resource_policy <- secretsmanager_delete_resource_policy secretsmanager_delete_secret <- function(SecretId, RecoveryWindowInDays = NULL, ForceDeleteWithoutRecovery = NULL) { op <- new_operation( name = "DeleteSecret", http_method = "POST", http_path = "/", paginator = list() ) input <- .secretsmanager$delete_secret_input(SecretId = SecretId, RecoveryWindowInDays = RecoveryWindowInDays, ForceDeleteWithoutRecovery = ForceDeleteWithoutRecovery) output <- .secretsmanager$delete_secret_output() config <- get_config() svc <- .secretsmanager$service(config) request <- new_request(svc, op, input, output) response <- send_request(request) return(response) } .secretsmanager$operations$delete_secret <- secretsmanager_delete_secret secretsmanager_describe_secret <- function(SecretId) { op <- new_operation( name = "DescribeSecret", http_method = "POST", http_path = "/", paginator = list() ) input <- .secretsmanager$describe_secret_input(SecretId = SecretId) output <- .secretsmanager$describe_secret_output() config <- get_config() svc <- .secretsmanager$service(config) request <- new_request(svc, op, input, output) response <- send_request(request) return(response) } .secretsmanager$operations$describe_secret <- secretsmanager_describe_secret secretsmanager_get_random_password <- function(PasswordLength = NULL, ExcludeCharacters = NULL, ExcludeNumbers = NULL, ExcludePunctuation = NULL, ExcludeUppercase = NULL, ExcludeLowercase = NULL, IncludeSpace = NULL, RequireEachIncludedType = NULL) { op <- new_operation( name = "GetRandomPassword", http_method = "POST", http_path = "/", paginator = list() ) input <- .secretsmanager$get_random_password_input(PasswordLength = PasswordLength, ExcludeCharacters = ExcludeCharacters, ExcludeNumbers = ExcludeNumbers, ExcludePunctuation = ExcludePunctuation, ExcludeUppercase = ExcludeUppercase, ExcludeLowercase = ExcludeLowercase, IncludeSpace = IncludeSpace, RequireEachIncludedType = RequireEachIncludedType) output <- .secretsmanager$get_random_password_output() config <- get_config() svc <- .secretsmanager$service(config) request <- new_request(svc, op, input, output) response <- send_request(request) return(response) } .secretsmanager$operations$get_random_password <- secretsmanager_get_random_password secretsmanager_get_resource_policy <- function(SecretId) { op <- new_operation( name = "GetResourcePolicy", http_method = "POST", http_path = "/", paginator = list() ) input <- .secretsmanager$get_resource_policy_input(SecretId = SecretId) output <- .secretsmanager$get_resource_policy_output() config <- get_config() svc <- .secretsmanager$service(config) request <- new_request(svc, op, input, output) response <- send_request(request) return(response) } .secretsmanager$operations$get_resource_policy <- secretsmanager_get_resource_policy secretsmanager_get_secret_value <- function(SecretId, VersionId = NULL, VersionStage = NULL) { op <- new_operation( name = "GetSecretValue", http_method = "POST", http_path = "/", paginator = list() ) input <- .secretsmanager$get_secret_value_input(SecretId = SecretId, VersionId = VersionId, VersionStage = VersionStage) output <- .secretsmanager$get_secret_value_output() config <- get_config() svc <- .secretsmanager$service(config) request <- new_request(svc, op, input, output) response <- send_request(request) return(response) } .secretsmanager$operations$get_secret_value <- secretsmanager_get_secret_value secretsmanager_list_secret_version_ids <- function(SecretId, MaxResults = NULL, NextToken = NULL, IncludeDeprecated = NULL) { op <- new_operation( name = "ListSecretVersionIds", http_method = "POST", http_path = "/", paginator = list() ) input <- .secretsmanager$list_secret_version_ids_input(SecretId = SecretId, MaxResults = MaxResults, NextToken = NextToken, IncludeDeprecated = IncludeDeprecated) output <- .secretsmanager$list_secret_version_ids_output() config <- get_config() svc <- .secretsmanager$service(config) request <- new_request(svc, op, input, output) response <- send_request(request) return(response) } .secretsmanager$operations$list_secret_version_ids <- secretsmanager_list_secret_version_ids secretsmanager_list_secrets <- function(MaxResults = NULL, NextToken = NULL, Filters = NULL, SortOrder = NULL) { op <- new_operation( name = "ListSecrets", http_method = "POST", http_path = "/", paginator = list() ) input <- .secretsmanager$list_secrets_input(MaxResults = MaxResults, NextToken = NextToken, Filters = Filters, SortOrder = SortOrder) output <- .secretsmanager$list_secrets_output() config <- get_config() svc <- .secretsmanager$service(config) request <- new_request(svc, op, input, output) response <- send_request(request) return(response) } .secretsmanager$operations$list_secrets <- secretsmanager_list_secrets secretsmanager_put_resource_policy <- function(SecretId, ResourcePolicy, BlockPublicPolicy = NULL) { op <- new_operation( name = "PutResourcePolicy", http_method = "POST", http_path = "/", paginator = list() ) input <- .secretsmanager$put_resource_policy_input(SecretId = SecretId, ResourcePolicy = ResourcePolicy, BlockPublicPolicy = BlockPublicPolicy) output <- .secretsmanager$put_resource_policy_output() config <- get_config() svc <- .secretsmanager$service(config) request <- new_request(svc, op, input, output) response <- send_request(request) return(response) } .secretsmanager$operations$put_resource_policy <- secretsmanager_put_resource_policy secretsmanager_put_secret_value <- function(SecretId, ClientRequestToken = NULL, SecretBinary = NULL, SecretString = NULL, VersionStages = NULL) { op <- new_operation( name = "PutSecretValue", http_method = "POST", http_path = "/", paginator = list() ) input <- .secretsmanager$put_secret_value_input(SecretId = SecretId, ClientRequestToken = ClientRequestToken, SecretBinary = SecretBinary, SecretString = SecretString, VersionStages = VersionStages) output <- .secretsmanager$put_secret_value_output() config <- get_config() svc <- .secretsmanager$service(config) request <- new_request(svc, op, input, output) response <- send_request(request) return(response) } .secretsmanager$operations$put_secret_value <- secretsmanager_put_secret_value secretsmanager_restore_secret <- function(SecretId) { op <- new_operation( name = "RestoreSecret", http_method = "POST", http_path = "/", paginator = list() ) input <- .secretsmanager$restore_secret_input(SecretId = SecretId) output <- .secretsmanager$restore_secret_output() config <- get_config() svc <- .secretsmanager$service(config) request <- new_request(svc, op, input, output) response <- send_request(request) return(response) } .secretsmanager$operations$restore_secret <- secretsmanager_restore_secret secretsmanager_rotate_secret <- function(SecretId, ClientRequestToken = NULL, RotationLambdaARN = NULL, RotationRules = NULL) { op <- new_operation( name = "RotateSecret", http_method = "POST", http_path = "/", paginator = list() ) input <- .secretsmanager$rotate_secret_input(SecretId = SecretId, ClientRequestToken = ClientRequestToken, RotationLambdaARN = RotationLambdaARN, RotationRules = RotationRules) output <- .secretsmanager$rotate_secret_output() config <- get_config() svc <- .secretsmanager$service(config) request <- new_request(svc, op, input, output) response <- send_request(request) return(response) } .secretsmanager$operations$rotate_secret <- secretsmanager_rotate_secret secretsmanager_tag_resource <- function(SecretId, Tags) { op <- new_operation( name = "TagResource", http_method = "POST", http_path = "/", paginator = list() ) input <- .secretsmanager$tag_resource_input(SecretId = SecretId, Tags = Tags) output <- .secretsmanager$tag_resource_output() config <- get_config() svc <- .secretsmanager$service(config) request <- new_request(svc, op, input, output) response <- send_request(request) return(response) } .secretsmanager$operations$tag_resource <- secretsmanager_tag_resource secretsmanager_untag_resource <- function(SecretId, TagKeys) { op <- new_operation( name = "UntagResource", http_method = "POST", http_path = "/", paginator = list() ) input <- .secretsmanager$untag_resource_input(SecretId = SecretId, TagKeys = TagKeys) output <- .secretsmanager$untag_resource_output() config <- get_config() svc <- .secretsmanager$service(config) request <- new_request(svc, op, input, output) response <- send_request(request) return(response) } .secretsmanager$operations$untag_resource <- secretsmanager_untag_resource secretsmanager_update_secret <- function(SecretId, ClientRequestToken = NULL, Description = NULL, KmsKeyId = NULL, SecretBinary = NULL, SecretString = NULL) { op <- new_operation( name = "UpdateSecret", http_method = "POST", http_path = "/", paginator = list() ) input <- .secretsmanager$update_secret_input(SecretId = SecretId, ClientRequestToken = ClientRequestToken, Description = Description, KmsKeyId = KmsKeyId, SecretBinary = SecretBinary, SecretString = SecretString) output <- .secretsmanager$update_secret_output() config <- get_config() svc <- .secretsmanager$service(config) request <- new_request(svc, op, input, output) response <- send_request(request) return(response) } .secretsmanager$operations$update_secret <- secretsmanager_update_secret secretsmanager_update_secret_version_stage <- function(SecretId, VersionStage, RemoveFromVersionId = NULL, MoveToVersionId = NULL) { op <- new_operation( name = "UpdateSecretVersionStage", http_method = "POST", http_path = "/", paginator = list() ) input <- .secretsmanager$update_secret_version_stage_input(SecretId = SecretId, VersionStage = VersionStage, RemoveFromVersionId = RemoveFromVersionId, MoveToVersionId = MoveToVersionId) output <- .secretsmanager$update_secret_version_stage_output() config <- get_config() svc <- .secretsmanager$service(config) request <- new_request(svc, op, input, output) response <- send_request(request) return(response) } .secretsmanager$operations$update_secret_version_stage <- secretsmanager_update_secret_version_stage secretsmanager_validate_resource_policy <- function(SecretId = NULL, ResourcePolicy) { op <- new_operation( name = "ValidateResourcePolicy", http_method = "POST", http_path = "/", paginator = list() ) input <- .secretsmanager$validate_resource_policy_input(SecretId = SecretId, ResourcePolicy = ResourcePolicy) output <- .secretsmanager$validate_resource_policy_output() config <- get_config() svc <- .secretsmanager$service(config) request <- new_request(svc, op, input, output) response <- send_request(request) return(response) } .secretsmanager$operations$validate_resource_policy <- secretsmanager_validate_resource_policy
na_plot = function(data, palette = ez_col) { cols = names(data) data = data %>% ungroup %>% mutate_all(function(x) ifelse(is.na(x), "NA", "Value")) data$.row = seq_len(nrow(data)) tidyr::gather(data, column, value, -.row) %>% mutate(column = factor(column, cols), value = factor(value, c("Value", "NA"))) %>% ggplot() + geom_tile(aes(column, .row, fill = value, colour = value)) + scale_fill_manual(NULL, values = palette(2)) + scale_colour_manual(NULL, values = c(NA, palette(2)[2])) + scale_y_reverse() + scale_x_discrete(position = "top") + xlab(NULL) + ylab("row") + theme_minimal() + coord_cartesian(expand = FALSE) + theme(axis.text.x = element_text(angle = 90, hjust = 0, vjust = 0.38)) } globalVariables(c("column", "value", ".row"))
xbio <- structure(list(`1971` = c(1371500, 1367850, 1383830, 1433910, 1454380, 1504840, 1475500, 1318360, 1206740, 1297190, 1337360, 1349590, 1371760, 1375640, 1400150, 1394810, 1384870, 1429970, 1311740, 1340750, 1399290, 1365930, 1346000, 1239810, 1305410, 1360350, 1319530, 1309230, 1395870, 1370630, 1422550, 1385840, 1430720, 1493640, 1449010, 1508920, 1510880, 1463250, 1431290, 1423290, 1404940, 1323510, 1377750, 1318550, 1349120, 1431920, 1436070, 1366540, 1282990, 1320490, 1334270, 1407460, 1391460, 1454810, 1432740, 1407470, 1424290, 1377040, 1422880, 1391310, 1378690, 1357190, 1368370, 1390470, 1386700, 1410740, 1326580, 1266200, 1344450, 1379510, 1400780, 1443520, 1416650, 1390370, 1360140, 1365050, 1321770, 1262260, 1365510, 1420030, 1312290, 1273080, 1278780, 1358050, 1333310, 1301200, 1288300, 1327560, 1371940, 1428440, 1454630, 1429010, 1330180, 1365590, 1313130, 1403490, 1326850, 1384740, 1427880, 1377680, 1314850, 1487140, 1511580, 1463610, 1451030, 1338750, 1362760, 1364520, 1336710, 1441480, 1511930, 1486610, 1591010, 1643700, 1610980, 1660020, 1384740, 1417060, 1343860, 1259360, 1201970, 1181850, 1213580, 1123790, 1215320, 1308440, 1288760, 1311730, 1304310, 1246480, 1219900, 1196720, 1305850, 1351550, 1322300, 1306110, 1140290, 1093450, 1053660, 1133470, 1089810, 1178960, 1233320, 1229060, 1291870, 1339520, 1246100, 1254120, 1254770, 1204480, 1311720, 1331770, 1348950, 1449920, 1347210, 1310810, 1242080, 1254720, 1417450, 1475100, 1344060, 1411600, 1470520, 1399340, 1414800, 1450160, 1432880, 1361020, 1345200, 1284680, 1333600, 1387760, 1452380, 1322220, 1259120, 1224120, 1357550, 1330230, 1359120, 1366840, 1267840, 1188160, 1241830, 1272120, 1206620, 1244530, 1249010, 1311860, 1339810, 1336150, 1328220, 1358710, 1301110, 1325740, 1334520, 1326320, 1312590, 1297930, 1406580, 1349370, 1420680, 1428260, 1404660, 1404100, 1381890, 1387210, 1454710, 1369910, 1310440, 1324010, 1209560, 1294350, 1275120, 1334180, 1210030, 1260240, 1244470, 1275750, 1312920, 1440680, 1362460, 1381060, 1315030, 1252720, 1281560, 1316670, 1349980, 1418020, 1503190, 1438470, 1372050, 1332850, 1274980, 1249570, 1289110, 1277690, 1411550, 1386890, 1348410, 1492390, 1370940, 1319910, 1325090, 1293000, 1236100, 1361670, 1353140, 1437870, 1376290, 1332430, 1384330, 1458970, 1375390, 1382700, 1385690, 1431820, 1535930, 1509110, 1532370, 1498030, 1427480, 1495850, 1406940, 1484430, 1409130, 1359060, 1240610, 1437740, 1337950, 1292180, 1400040, 1299780, 1462010, 1508210, 1480660, 1344030, 1378980, 1403400, 1347040, 1237900, 1316720, 1306540, 1206380, 1283480, 1312430, 1331550, 1320010, 1388340, 1488440, 1362220, 1377850, 1359470, 1410460, 1384770, 1389830, 1389710, 1357870, 1377620, 1322770, 1372560, 1324320, 1376170, 1414580, 1367590, 1380910, 1357130, 1371900, 1325570, 1367060, 1373950, 1414290, 1408710, 1478790, 1459330, 1355060, 1377180, 1334070, 1266170, 1245630, 1281240, 1322130, 1316880, 1360830, 1376870, 1227130, 1264820, 1269690, 1265140, 1298420, 1308750, 1333440, 1334430, 1285410, 1329910, 1340770, 1360030, 1316020, 1311240, 1314450, 1406170, 1301780, 1279020, 1426180, 1449690, 1291450, 1341810, 1365900, 1281080, 1238620, 1275890, 1303960, 1239530, 1236160, 1251940, 1323410, 1327890, 1296770, 1330270, 1282870, 1205970, 1211310, 1245080, 1394920, 1416110, 1473840, 1383650, 1392820, 1359040, 1369170, 1378310, 1429870, 1382270, 1283720, 1315670, 1283720, 1216090, 1178820, 1216040, 1296950, 1443660, 1413520, 1546680, 1451410, 1543090, 1493720, 1504770, 1455570, 1414410, 1583990, 1583900, 1473910, 1410970, 1471570, 1401890, 1316290, 1338150, 1369580, 1445310, 1333850, 1294560, 1442610, 1567370, 1562430, 1573210, 1608900, 1540420, 1481350, 1411200, 1397330, 1432320, 1423220, 1400920, 1308700, 1373540, 1349420, 1306560, 1336980, 1367370, 1403660, 1403140, 1396600, 1234600, 1321540, 1333340, 1294340, 1403360, 1393220, 1270380, 1326550, 1380410, 1548330, 1405620, 1519780, 1323360, 1464950, 1480840, 1355190, 1264250, 1287610, 1349160, 1322870, 1288830, 1215720, 1279360, 1157720, 1252240, 1304020, 1256630, 1240960, 1276990, 1316140, 1380370, 1385800, 1439640, 1394340, 1306020, 1258650, 1312650, 1425070, 1349290, 1369400, 1371030, 1322500, 1374240, 1334400, 1282620, 1336360, 1431110, 1495150, 1409400, 1376570, 1428690, 1364260, 1426460, 1354260, 1462900, 1471250, 1471630, 1472210, 1580500, 1576730, 1462310, 1411440, 1391130, 1492850, 1450210, 1480450, 1522550, 1403350, 1347060, 1263260, 1248170, 1259880, 1337160, 1297230, 1348580, 1325770, 1267310, 1314560, 1307080, 1293890, 1357560, 1344540, 1246140, 1296910, 1303710, 1300450, 1256070, 1295910, 1336980, 1340030, 1375480, 1445880, 1408630, 1372180, 1335650, 1325010, 1284980, 1251680, 1323300, 1380960, 1390550, 1286650, 1387750, 1418140, 1476670, 1406860, 1401750, 1348260, 1471870, 1388520, 1398390, 1447130, 1434590, 1412790, 1304500, 1428460, 1344010, 1224700, 1320740, 1400080, 1362320, 1321920, 1295060, 1314260, 1284510, 1334010, 1378500, 1326770, 1416780, 1404280, 1326970, 1296920, 1231750, 1363700, 1374560, 1343430, 1376340, 1440950, 1368100, 1265310, 1341950, 1326520, 1359200, 1341050, 1285910, 1242310, 1229590, 1232970, 1269970, 1332680, 1328770, 1288520, 1280640, 1316130, 1338940, 1382180, 1418080, 1493570, 1483590, 1512650, 1428910, 1328650, 1318940, 1305730, 1229410, 1289120, 1260300, 1249820, 1226300, 1152180, 1128890, 1187320, 1257850, 1257510, 1350360, 1383710, 1324560, 1340620, 1278240, 1308060, 1363160, 1343330, 1245510, 1380960, 1451110, 1422540, 1391290, 1311270, 1384450, 1361160, 1361780, 1346990, 1413240, 1449660, 1446290, 1493060, 1372090, 1381480, 1502920, 1457320, 1429730, 1230420, 1267990, 1372050, 1303300, 1297930, 1318470, 1368570, 1435120, 1441860, 1463880, 1395210, 1438200, 1365790, 1381780, 1448960, 1393740, 1371100, 1412270, 1519570, 1419820, 1466810, 1502990, 1417690, 1417540, 1382830, 1394040, 1477550, 1428080, 1380420, 1409970, 1332790, 1303920, 1294910, 1253210, 1267870, 1302520, 1227100, 1322350, 1349180, 1214530, 1296090, 1316730, 1318440, 1271460, 1261110, 1257640, 1339750, 1304040, 1332460, 1248670, 1307870, 1392500, 1424160, 1449030, 1543320, 1468940, 1392090, 1319730, 1331440, 1385230, 1421290, 1398190, 1431140, 1446590, 1379340, 1396720, 1402820, 1324770, 1381440, 1418730, 1440090, 1426910, 1434530, 1409190, 1381440, 1418560, 1362510, 1336120, 1337820, 1334370, 1363460, 1421450, 1437360, 1454560, 1407010, 1479080, 1500790, 1468630, 1415140, 1336120, 1430940, 1403990, 1482080, 1629340, 1491420, 1375820, 1424710, 1379820, 1472430, 1346590, 1378530, 1296360, 1290360, 1245820, 1234310, 1332290, 1278930, 1305320, 1328430, 1283890, 1231070, 1187330, 1271540, 1319880, 1372700, 1323960, 1324980, 1471570, 1571790, 1524630, 1472460, 1406070, 1289630, 1236440, 1185120, 1338870, 1402290, 1368220, 1411640, 1441720, 1395770, 1411010, 1465850, 1365360, 1332740, 1291900, 1338840, 1232330, 1235560, 1265160, 1278170, 1387370, 1364220, 1353170, 1312610, 1285130, 1278330, 1260210, 1394750, 1557620, 1439490, 1423720, 1437010, 1325980, 1477990, 1494880, 1422220, 1332120, 1476040, 1458160, 1434900, 1385680, 1353920, 1329530, 1384970, 1460550, 1436930, 1386150, 1391450, 1399910, 1375190, 1342180, 1440680, 1391670, 1416160, 1397710, 1369080, 1356150, 1396430, 1473830, 1519730, 1529740, 1486310, 1378140, 1345390, 1330020, 1243400, 1325530, 1301520, 1314690, 1370900, 1350680, 1347940, 1395110, 1416760, 1460860, 1434590, 1350810, 1317660, 1306230, 1368010, 1387090, 1314480, 1417820, 1407450, 1362420, 1366440, 1302370, 1401760, 1444500, 1394410, 1407290, 1390140, 1438110, 1435660, 1347020, 1327600, 1374140, 1394430, 1338380, 1358800, 1354850, 1396260, 1487760, 1555610, 1491710, 1607460, 1535900, 1443730, 1385770, 1356100, 1354850, 1292730, 1343190, 1316850, 1360930, 1273470, 1340380, 1448020, 1470350, 1599930, 1421110, 1476260, 1439140, 1460930, 1477850, 1464080, 1427720, 1463830, 1320420, 1383970, 1418850, 1299250, 1261440, 1297330, 1399720, 1325710, 1344140, 1325190, 1270070, 1289710, 1236350, 1274100, 1369470, 1225310, 1243450, 1285780, 1381700, 1330510, 1366460, 1286310, 1390320, 1360200, 1374630, 1261170, 1275470, 1309410, 1242720, 1246790, 1312030, 1360190, 1280980, 1293300, 1266610, 1225150, 1276490, 1338250, 1354140, 1281630, 1301410, 1315650, 1451180, 1462360, 1457780, 1501410, 1470330, 1387300, 1392430, 1459740, 1327540, 1252630, 1409440, 1397370, 1303310, 1366560, 1324510, 1362210, 1353290, 1302080, 1387580, 1262620, 1306040, 1245060, 1186410, 1313640, 1335630, 1366520, 1429310, 1519970, 1460680, 1546700, 1487220, 1432900, 1408440, 1409470, 1460080, 1395110, 1368400, 1447600, 1457230, 1443130, 1389770, 1393570, 1460840, 1444430, 1343000, 1190130, 1280560, 1247000, 1185050, 1206700, 1286380, 1333980, 1408090, 1400520, 1384590, 1388120, 1296960, 1256370, 1301070, 1369230, 1390790, 1474950, 1402070, 1444760, 1357980, 1438730, 1481910, 1509580, 1361030, 1351200, 1444840, 1404560, 1402050, 1437770, 1480750, 1392490, 1313080, 1328020, 1256950, 1311110, 1264710, 1413830, 1397510, 1326120, 1327880, 1317340, 1313280), `1972` = c(1173380, 1141220, 1161050, 1191650, 1185550, 1242840, 1239870, 1110610, 1023190, 1131690, 1144820, 1159280, 1166890, 1145640, 1213990, 1181120, 1165540, 1202870, 1113200, 1152280, 1148370, 1118610, 1141090, 1040130, 1097300, 1170280, 1143410, 1139080, 1183230, 1199640, 1238630, 1152590, 1190750, 1261160, 1202230, 1285020, 1265330, 1291860, 1199250, 1189300, 1200090, 1108130, 1142730, 1133130, 1114630, 1250130, 1246550, 1168870, 1050500, 1084490, 1082210, 1137280, 1131820, 1198480, 1193780, 1154250, 1192010, 1165140, 1210920, 1225210, 1219340, 1136090, 1180310, 1165480, 1177260, 1202140, 1106110, 1101420, 1166230, 1202680, 1235420, 1285100, 1213890, 1216810, 1193330, 1181160, 1135940, 1053410, 1136710, 1221990, 1128220, 1139280, 1176110, 1251770, 1196150, 1108110, 1081640, 1110200, 1145110, 1229380, 1291990, 1289340, 1217480, 1283090, 1245890, 1284610, 1187740, 1163520, 1180670, 1157720, 1101970, 1319950, 1338390, 1296840, 1299400, 1231930, 1197700, 1208070, 1174730, 1280000, 1321030, 1342770, 1409530, 1471410, 1419420, 1472400, 1175040, 1257820, 1175460, 1148540, 1060350, 1041850, 1089370, 1026550, 1043100, 1127390, 1069690, 1105410, 1152840, 1102590, 1080130, 1050570, 1164790, 1170110, 1206360, 1203350, 1040230, 1060510, 1025720, 1025610, 979663, 1066470, 1090100, 1038280, 1093060, 1165230, 1051530, 1066250, 1052770, 1022050, 1122070, 1205630, 1259670, 1255710, 1161990, 1134590, 1129560, 1136060, 1256330, 1320120, 1162580, 1198400, 1303560, 1193830, 1218890, 1238990, 1222000, 1192070, 1166310, 1081580, 1120730, 1174580, 1244110, 1133900, 1077400, 1017610, 1171020, 1168900, 1172290, 1169860, 1171440, 1050470, 1136150, 1167610, 1095510, 1159370, 1047840, 1083350, 1114740, 1091450, 1103010, 1122820, 1101390, 1155200, 1136490, 1149690, 1163370, 1187550, 1233280, 1157370, 1203800, 1266810, 1241710, 1221050, 1189010, 1234180, 1271630, 1199230, 1123360, 1158500, 1066140, 1147740, 1148540, 1171770, 1059910, 1105440, 1044150, 1064160, 1171300, 1309140, 1238690, 1228560, 1192660, 1097710, 1143940, 1139140, 1147690, 1209810, 1263940, 1225230, 1209070, 1158900, 1118530, 1090420, 1103540, 1091620, 1204660, 1212940, 1160970, 1280720, 1157930, 1134400, 1176680, 1086060, 1054710, 1230310, 1174950, 1220530, 1187790, 1163760, 1221460, 1302160, 1196360, 1207520, 1209690, 1304390, 1381720, 1368220, 1361230, 1293840, 1267630, 1310690, 1250030, 1301950, 1234970, 1164180, 1122860, 1267740, 1214790, 1121500, 1208160, 1165220, 1264620, 1294340, 1299380, 1186200, 1207200, 1187010, 1112360, 1062010, 1093810, 1092640, 1004740, 1029530, 1118200, 1191230, 1113560, 1179450, 1258100, 1149110, 1162030, 1136910, 1187020, 1135720, 1161840, 1183490, 1182200, 1167710, 1119690, 1157900, 1172250, 1217340, 1266030, 1207880, 1185970, 1137630, 1168920, 1127460, 1176680, 1161860, 1203780, 1183080, 1225150, 1229470, 1127510, 1102960, 1105260, 1079150, 1088450, 1138700, 1148570, 1153820, 1138050, 1223870, 1112250, 1153510, 1190150, 1118450, 1142310, 1149580, 1169060, 1175300, 1119430, 1148910, 1114030, 1157070, 1108020, 1108250, 1142270, 1261260, 1141950, 1106350, 1244200, 1282330, 1140690, 1196470, 1217470, 1165590, 1119800, 1118790, 1148360, 1090910, 1076010, 1054660, 1128600, 1105620, 1056690, 1109170, 1090140, 1057650, 1072090, 1088480, 1222560, 1269670, 1322240, 1187380, 1206910, 1196210, 1155860, 1171760, 1211950, 1163800, 1071080, 1126040, 1094020, 1042830, 986440, 1003250, 1056540, 1202340, 1189700, 1301630, 1256350, 1356670, 1339670, 1307500, 1263090, 1232810, 1312060, 1352790, 1276660, 1189390, 1273510, 1180220, 1160770, 1144580, 1169990, 1198360, 1148300, 1065760, 1247850, 1335890, 1367690, 1368940, 1398280, 1304300, 1293700, 1178890, 1143280, 1205040, 1230410, 1181590, 1072150, 1156210, 1124960, 1071270, 1075880, 1143180, 1217630, 1236130, 1247540, 1059280, 1084130, 1115410, 1137140, 1237200, 1195450, 1089540, 1141030, 1232520, 1380100, 1215230, 1343360, 1197440, 1326980, 1285080, 1143090, 1107720, 1090820, 1162710, 1173040, 1113740, 1032030, 1109850, 1033190, 1096230, 1127880, 1084120, 1084970, 1102950, 1106510, 1188560, 1164160, 1184780, 1153640, 1111760, 1052200, 1080610, 1162900, 1104020, 1159920, 1180580, 1091570, 1154180, 1131450, 1080980, 1151130, 1247090, 1285680, 1211720, 1221500, 1236310, 1157120, 1199370, 1131020, 1274500, 1293830, 1266770, 1271870, 1400210, 1371040, 1252430, 1208480, 1175570, 1230220, 1188110, 1221020, 1243910, 1141780, 1122260, 1094290, 1039200, 1064330, 1128820, 1100830, 1113970, 1083650, 1019310, 1090850, 1077690, 1042100, 1081980, 1104770, 1074490, 1146630, 1174340, 1160920, 1132140, 1147570, 1205010, 1184240, 1200580, 1257470, 1224630, 1161770, 1154430, 1151230, 1109240, 1073120, 1169760, 1195000, 1204090, 1130210, 1256660, 1263490, 1336420, 1230390, 1207880, 1129050, 1239960, 1162110, 1187240, 1247630, 1246820, 1194490, 1148370, 1289310, 1204380, 1063890, 1139210, 1174790, 1126360, 1139990, 1084220, 1078070, 1046930, 1070110, 1073020, 1033960, 1127890, 1131740, 1069060, 1049230, 991962, 1119480, 1142450, 1158500, 1174100, 1225630, 1184700, 1093020, 1135150, 1148570, 1153260, 1096450, 1081340, 1082720, 1042320, 1065960, 1118590, 1196550, 1184910, 1115510, 1083550, 1080310, 1124930, 1181370, 1199310, 1279160, 1245670, 1330220, 1251180, 1179020, 1190130, 1161190, 1093490, 1111690, 1076270, 1053280, 1040530, 992595, 996419, 1057980, 1146820, 1117620, 1168710, 1215560, 1203540, 1178470, 1100560, 1139330, 1200050, 1165680, 1042650, 1177390, 1290070, 1237650, 1198610, 1142700, 1156780, 1127910, 1153210, 1137220, 1234510, 1294110, 1275770, 1292250, 1168550, 1215110, 1322510, 1251600, 1253170, 1115690, 1121780, 1216540, 1211090, 1205350, 1167410, 1171930, 1242780, 1243910, 1212460, 1187490, 1245390, 1201150, 1207590, 1225290, 1173970, 1152840, 1220370, 1296500, 1239550, 1279930, 1321680, 1229670, 1208050, 1159730, 1196170, 1254520, 1202320, 1140860, 1168950, 1071610, 1065230, 1083290, 1023620, 1056260, 1115600, 1077770, 1131370, 1141250, 1043950, 1123030, 1132330, 1191300, 1114970, 1071600, 1056740, 1166330, 1119240, 1124300, 1042420, 1131510, 1180400, 1185550, 1235860, 1283420, 1256380, 1189060, 1098760, 1114800, 1169140, 1183670, 1135950, 1192950, 1200760, 1155060, 1179890, 1205770, 1179200, 1191540, 1209470, 1221270, 1202960, 1229950, 1203920, 1219630, 1250320, 1154200, 1096200, 1111260, 1140680, 1154280, 1236090, 1230280, 1258240, 1183770, 1226220, 1249710, 1237290, 1256420, 1201250, 1259290, 1226650, 1318540, 1420120, 1266310, 1212340, 1216080, 1156610, 1271490, 1191930, 1222920, 1122220, 1077820, 1073670, 1061790, 1159810, 1132220, 1134390, 1107310, 1075040, 1030560, 956488, 1060540, 1103040, 1146590, 1100180, 1079290, 1256210, 1367740, 1332150, 1265560, 1227760, 1139860, 1103260, 1043150, 1182220, 1215580, 1183500, 1199410, 1214850, 1197840, 1208730, 1262670, 1167630, 1102760, 1113330, 1149420, 1068310, 1075120, 1139050, 1136430, 1210400, 1180580, 1157130, 1117070, 1096790, 1068660, 1118700, 1238210, 1380980, 1283340, 1287990, 1286570, 1213060, 1294660, 1274570, 1214800, 1125550, 1276450, 1300170, 1278880, 1228740, 1153540, 1151200, 1148450, 1217690, 1212210, 1146100, 1178480, 1188430, 1160930, 1123240, 1212610, 1177520, 1196650, 1156540, 1132360, 1132520, 1164590, 1235580, 1275770, 1291400, 1260630, 1194260, 1162840, 1179220, 1121450, 1143920, 1104480, 1111870, 1135440, 1137690, 1179410, 1190270, 1222800, 1276090, 1236350, 1137450, 1093300, 1060000, 1148620, 1188760, 1153670, 1200340, 1147860, 1124170, 1152910, 1076710, 1140850, 1221840, 1219650, 1248240, 1203940, 1219720, 1199240, 1116600, 1122260, 1171430, 1162210, 1139280, 1143200, 1201500, 1198040, 1301390, 1371020, 1356250, 1458450, 1356300, 1266870, 1168700, 1071580, 1100620, 1044910, 1088260, 1068810, 1097410, 1001210, 1050590, 1223870, 1213950, 1311870, 1206010, 1256000, 1218130, 1229840, 1266060, 1265310, 1252410, 1277530, 1138130, 1209530, 1220930, 1128200, 1109800, 1127870, 1200850, 1184160, 1191790, 1171040, 1079540, 1118640, 1032630, 1086690, 1158110, 1060620, 1085220, 1172710, 1210530, 1171480, 1229830, 1178510, 1260660, 1179500, 1180300, 1065310, 1059480, 1098210, 1046650, 1066600, 1130110, 1177160, 1086020, 1132860, 1076850, 1026300, 1089250, 1168590, 1163230, 1125920, 1189190, 1197280, 1337620, 1346000, 1318150, 1371070, 1283300, 1270570, 1267790, 1251500, 1171190, 1107960, 1246620, 1202790, 1161370, 1199350, 1128400, 1199170, 1170580, 1123220, 1192170, 1091010, 1107290, 1048210, 976980, 1081080, 1090040, 1113000, 1165830, 1248310, 1200140, 1299160, 1202840, 1165500, 1184580, 1198460, 1222330, 1158700, 1162470, 1269320, 1305530, 1228970, 1200280, 1238620, 1317370, 1265980, 1193420, 1063160, 1128700, 1105260, 1061890, 1065430, 1137080, 1170220, 1241780, 1250240, 1232560, 1226410, 1102440, 1095870, 1144350, 1168190, 1173730, 1205910, 1177150, 1195400, 1109290, 1168320, 1234110, 1283190, 1169140, 1142650, 1217420, 1214880, 1210610, 1233120, 1269440, 1224290, 1136010, 1168050, 1113780, 1121160, 1087690, 1251310, 1191850, 1143640, 1173370, 1109680, 1117640), `1973` = c(894552, 898144, 932657, 926276, 907961, 926415, 949296, 834686, 731534, 838377, 887892, 934337, 904397, 923097, 974339, 940583, 914602, 922635, 833814, 880560, 865803, 828105, 881052, 847332, 894222, 934530, 924121, 912166, 917277, 908321, 946123, 834354, 897757, 975889, 921171, 978653, 949323, 982315, 894020, 879388, 911117, 843353, 844825, 864576, 856756, 945724, 939076, 886600, 762069, 776428, 772242, 805249, 800401, 839122, 863267, 847580, 867620, 873715, 917328, 960268, 939178, 824441, 861692, 807102, 835317, 903473, 790076, 829938, 846826, 899077, 941944, 1008930, 944875, 930108, 912958, 871453, 857004, 782515, 844872, 926911, 845122, 852950, 883550, 941776, 891807, 826821, 827245, 848992, 913059, 968120, 1037980, 1017000, 955481, 1050360, 1003830, 1001140, 905272, 879290, 861870, 856881, 801810, 1018790, 1032470, 982557, 966122, 909410, 870537, 862786, 845875, 946927, 989184, 1035970, 1077900, 1102310, 1049150, 1096330, 881618, 958156, 855165, 844796, 782387, 810780, 862611, 813112, 804976, 901659, 852785, 927055, 960492, 917732, 868926, 840298, 901419, 869461, 955409, 974315, 848850, 904146, 819081, 810266, 801679, 864837, 864697, 809515, 872016, 900903, 848971, 884416, 860525, 840996, 904040, 1012120, 1018100, 974666, 915546, 892632, 896398, 893016, 952502, 1010980, 863228, 889711, 998234, 884229, 900272, 928160, 914630, 917410, 884512, 793175, 832204, 881324, 963686, 885814, 807475, 762962, 879401, 875029, 868467, 863760, 876642, 786880, 837501, 868425, 855607, 877941, 767211, 848003, 848597, 821996, 835472, 834242, 856850, 919391, 891824, 882723, 922340, 960693, 986764, 925368, 944537, 967816, 923937, 918709, 877861, 952420, 942937, 872594, 820391, 864638, 776192, 847593, 896662, 920399, 840411, 867796, 784132, 791289, 901442, 1053150, 996017, 1007210, 976279, 873897, 906141, 892062, 870014, 896953, 984871, 955180, 946481, 907632, 878100, 858240, 832901, 840961, 916383, 958796, 868545, 978292, 901420, 885570, 910275, 815180, 773657, 960014, 895368, 931867, 896270, 889402, 950888, 1048700, 960653, 960238, 929535, 1016640, 1046270, 1039390, 1028710, 953437, 963969, 991154, 956062, 999133, 961948, 884420, 859582, 980181, 943428, 873177, 938643, 890740, 1003000, 1020990, 1019110, 929339, 943300, 889305, 813649, 797179, 806140, 809812, 717890, 736908, 842756, 936318, 841132, 897418, 946256, 895654, 891308, 867780, 916058, 864601, 888850, 898294, 891123, 854542, 855373, 883395, 904046, 945591, 983642, 954900, 914970, 893014, 898600, 874344, 881149, 857064, 882891, 862758, 889305, 925644, 839588, 828394, 827344, 805709, 827472, 866289, 879537, 897505, 878047, 975736, 911175, 964654, 1013420, 930437, 906757, 899641, 931413, 966602, 848030, 851861, 824598, 873286, 822965, 827839, 865395, 1000160, 875788, 823947, 926873, 974325, 889391, 944253, 974035, 922213, 879130, 878417, 898369, 838414, 816021, 820286, 885631, 873658, 813166, 858187, 818801, 818591, 816336, 800601, 927212, 976570, 1052080, 972140, 958317, 942906, 869167, 875193, 888103, 859230, 786336, 868979, 846984, 791600, 735538, 744752, 781016, 883945, 893808, 949145, 997586, 1024970, 1009790, 979177, 954473, 931282, 949592, 1028640, 979201, 886338, 942731, 858474, 876281, 867076, 909965, 889724, 887271, 782474, 935167, 1000120, 1041620, 1019340, 1073760, 1004000, 1001880, 890781, 844059, 935189, 971096, 988721, 861874, 894066, 856345, 796403, 777126, 845801, 935641, 974741, 1005630, 848575, 835648, 860001, 888363, 967667, 927266, 833206, 894067, 980546, 1084310, 935549, 1023010, 972717, 1065610, 1021690, 886702, 873377, 856133, 901479, 912108, 845627, 797715, 853230, 789945, 856817, 876359, 819805, 811823, 832118, 817014, 880319, 853358, 853583, 847763, 829121, 794565, 791852, 875216, 839535, 873127, 953403, 854077, 904384, 849029, 823627, 856068, 934044, 950133, 893486, 968968, 944619, 876366, 883576, 846953, 948943, 990567, 931189, 952185, 1073520, 1062600, 964828, 923070, 893133, 926616, 891539, 929581, 937746, 864461, 824480, 815483, 763324, 770467, 849842, 814899, 829853, 808116, 760258, 823730, 806793, 751928, 759521, 805290, 839321, 892633, 914465, 928222, 902376, 927061, 989143, 943608, 929907, 988884, 940281, 884700, 900468, 920082, 875893, 835555, 926211, 931461, 953688, 887798, 979261, 979760, 1041930, 943691, 914167, 843872, 937239, 883534, 915430, 958529, 967767, 909722, 928841, 1051030, 948571, 834302, 906260, 909392, 859337, 875444, 810849, 835734, 776561, 778057, 779330, 772716, 822081, 840610, 782389, 777441, 746123, 874736, 896896, 918384, 911018, 966399, 918544, 844679, 838008, 882621, 871058, 826418, 803205, 828893, 797812, 814954, 839235, 921938, 928325, 860349, 823836, 809733, 896743, 927801, 925274, 957480, 930814, 1000180, 927794, 886438, 937403, 889072, 834721, 827400, 801156, 800080, 784736, 742594, 786959, 802352, 884233, 857400, 887866, 930075, 982037, 954318, 875225, 929452, 975430, 940895, 810077, 905077, 997069, 954757, 958142, 910289, 887732, 861509, 889936, 843021, 937503, 991582, 967108, 981515, 876365, 911871, 1007050, 942993, 964259, 871547, 883241, 960939, 961500, 940598, 906813, 885512, 954731, 979074, 924883, 870312, 904754, 879852, 901713, 903794, 860014, 863035, 901784, 938203, 926373, 975068, 1001690, 949590, 921626, 867870, 915886, 953108, 900196, 852347, 855502, 794029, 772328, 799737, 751154, 772766, 846392, 819020, 871602, 882973, 783569, 825901, 828112, 901457, 845541, 771043, 741021, 848690, 823605, 818014, 779932, 881610, 887413, 890656, 948854, 949389, 989570, 934100, 852021, 849935, 876029, 893864, 853023, 916872, 937621, 890985, 898793, 927745, 922561, 938497, 944509, 957210, 946398, 968552, 962628, 976503, 949857, 897277, 840639, 847528, 907331, 881622, 963577, 924533, 965213, 891612, 921132, 936640, 946511, 965870, 913508, 963461, 924620, 1046510, 1102160, 958631, 948131, 940543, 881920, 972285, 935635, 957661, 848696, 792285, 784066, 775972, 846035, 847222, 861643, 825843, 804215, 783535, 746538, 805511, 846033, 904121, 873461, 838342, 987289, 1051620, 1025850, 960499, 928971, 866311, 836031, 788859, 936905, 945115, 931884, 934685, 940298, 939290, 946743, 980640, 944276, 862623, 887186, 880350, 797926, 805748, 861215, 852845, 908314, 871825, 840614, 820997, 798454, 753433, 824826, 917366, 1022930, 983596, 1040050, 988460, 989591, 1016020, 969426, 929834, 857989, 987304, 1036920, 1010850, 968143, 895847, 908911, 870154, 919056, 892599, 871939, 893064, 903822, 905300, 872279, 927350, 884568, 927936, 876602, 861683, 856270, 898795, 969596, 1003990, 1020230, 987323, 948576, 909909, 909895, 892644, 907502, 855106, 832951, 848142, 841893, 880935, 886619, 921927, 929824, 910788, 849562, 825556, 787281, 838969, 895218, 869362, 900244, 841417, 864009, 863837, 821700, 831111, 932906, 931075, 1004870, 953928, 954418, 911307, 835996, 858109, 901014, 912241, 873110, 902186, 980430, 1001850, 1096960, 1121270, 1075600, 1145360, 1057110, 1012350, 913096, 784313, 856142, 770730, 858429, 835060, 843354, 760964, 779297, 935861, 910876, 1000770, 949373, 935383, 923337, 942558, 954693, 982093, 990659, 1028090, 884857, 925208, 929548, 860691, 887475, 897404, 939026, 922518, 948047, 907708, 828949, 871009, 776655, 810717, 838331, 775013, 813206, 893527, 921543, 893190, 950639, 930094, 997823, 908168, 874622, 814281, 810539, 857277, 864066, 859128, 888060, 927483, 842217, 896968, 855007, 857946, 915051, 977345, 916626, 919050, 944867, 942391, 1063100, 1075320, 1002690, 1086830, 978254, 1022930, 987003, 983675, 941135, 861360, 995302, 941827, 921903, 981068, 901965, 944020, 936647, 911078, 964366, 891116, 888305, 827643, 787206, 847289, 842232, 845075, 861432, 942814, 908943, 967830, 870890, 865557, 866343, 862892, 899875, 860327, 858857, 986935, 1044550, 929046, 928434, 967333, 1048220, 968486, 917666, 842376, 888533, 848598, 799335, 787452, 845547, 877765, 950573, 947226, 940203, 920329, 786839, 828746, 890370, 897487, 878073, 913058, 887961, 887765, 776666, 836585, 873275, 908401, 821024, 827524, 909254, 957485, 948491, 940667, 969718, 971373, 870073, 907595, 852585, 838231, 847428, 955233, 908287, 880829, 892895, 890657, 878303), `1974` = c(999547, 1015650, 1054840, 1030800, 976371, 975859, 1054580, 940445, 865316, 908639, 924488, 961415, 916633, 955731, 1020480, 1056780, 1006910, 1058350, 919273, 971699, 977095, 878085, 968184, 941520, 1050500, 1045740, 1055830, 1020990, 1035780, 1051240, 1107350, 1044180, 1084270, 1153860, 1059900, 1094830, 1010120, 1074150, 1049310, 948889, 974649, 946535, 1042310, 961443, 1034590, 1123580, 1084300, 1042100, 971366, 1059850, 951338, 959588, 931942, 919307, 942267, 929521, 963099, 988165, 1032380, 1095670, 1078460, 1019650, 1003660, 932001, 966893, 1007340, 925143, 995175, 925296, 979178, 1032810, 1045580, 1005670, 944919, 972425, 946569, 978004, 970739, 955483, 1016400, 1005200, 972110, 972045, 1005610, 989632, 967511, 989973, 1042550, 1082590, 1102060, 1136880, 1078220, 1015320, 1119990, 1094850, 1064820, 984520, 986825, 983338, 992139, 868480, 1076310, 1111370, 1076820, 1067590, 1040070, 1054560, 1064900, 1035120, 1037190, 1077210, 1135210, 1133150, 1150760, 1080470, 1116600, 1012270, 1046690, 982889, 1021180, 939511, 979031, 1005400, 969407, 921514, 984637, 984563, 1084680, 1097780, 1065450, 1025250, 951125, 1013790, 977382, 1089530, 1150760, 1057880, 1123010, 999056, 1000960, 967970, 1000730, 984140, 949760, 986537, 980834, 989094, 989564, 998203, 1014800, 1067530, 1100660, 1123490, 1063420, 1032580, 1015220, 1042250, 1020780, 1059100, 1100050, 954349, 997602, 1109940, 1022300, 1015930, 1036130, 1046790, 1053760, 1049420, 1053130, 1040900, 1022140, 1093190, 1043800, 958877, 888028, 919556, 917869, 941637, 958033, 963583, 869422, 930604, 958854, 975791, 1002710, 875484, 916982, 936618, 900488, 903560, 879105, 937533, 1007150, 971098, 944429, 1005010, 1042450, 1109190, 1069520, 1082230, 1112370, 1045470, 1039160, 998018, 1012870, 993801, 918000, 937813, 988679, 934820, 992161, 1022160, 1042070, 997704, 1047390, 976490, 941610, 1029710, 1149120, 1085040, 1128880, 1111600, 994410, 1075480, 1060310, 1009360, 973035, 1057120, 1080480, 1048500, 970913, 997229, 992503, 969905, 994411, 1074700, 1121070, 1021060, 1085780, 960508, 992315, 1036160, 945674, 948582, 1080690, 991752, 992118, 958191, 979611, 1043610, 1114380, 1130630, 1135650, 1109950, 1117600, 1098700, 1076550, 1060170, 1053760, 1054910, 1082960, 1077030, 1076620, 1054880, 990440, 965029, 1048050, 1044990, 972012, 992925, 991428, 1033790, 1057650, 1083870, 1013010, 1000130, 963077, 958465, 934964, 952959, 990050, 942330, 871616, 993267, 1109770, 993606, 1008130, 999828, 1001680, 967621, 992467, 971964, 925938, 953144, 958003, 1030420, 977054, 978299, 959793, 972560, 1052700, 1093080, 1082560, 1051610, 1045320, 1001530, 973604, 935123, 914700, 913915, 972645, 968638, 995173, 976877, 989840, 1002020, 942476, 956548, 945659, 992338, 1013110, 1031290, 1131390, 1058040, 1103330, 1123120, 1057840, 1006190, 962300, 988620, 1084130, 977165, 884479, 894272, 930898, 872011, 896405, 917897, 1021810, 963847, 919858, 945909, 1040910, 969000, 1008130, 1062770, 1019640, 1009230, 1027760, 1058830, 989518, 956134, 948007, 995305, 960577, 922178, 970114, 883460, 949774, 946631, 909077, 998639, 1069400, 1151360, 1100240, 1100610, 1092020, 1025750, 1044210, 1046960, 994625, 952030, 1022590, 1023070, 957188, 877444, 911962, 920767, 976118, 984521, 1028360, 1116460, 1092650, 1040850, 1026010, 1036570, 992198, 968352, 1073430, 1035410, 975023, 1059180, 971455, 963781, 936329, 1012170, 968428, 980079, 912492, 1068770, 1072880, 1094940, 1049550, 1094460, 1021890, 1062320, 977494, 943433, 978202, 1048840, 1086410, 1062370, 1039830, 977868, 884807, 873139, 913245, 1010770, 1027970, 1107780, 1023640, 943128, 996018, 1026570, 1041280, 1032600, 914304, 1010760, 1094600, 1157740, 1102810, 1159970, 1064900, 1143240, 1091700, 1002330, 1047310, 1006030, 1015370, 1056160, 1029060, 1051920, 1076950, 1002270, 1032190, 1044830, 961221, 954874, 945798, 939839, 1016510, 939248, 879040, 907280, 911739, 916824, 902461, 997566, 976280, 989639, 1087730, 951019, 1023480, 901031, 887694, 929095, 970626, 931968, 941582, 984676, 970680, 925155, 918125, 928761, 995105, 1046380, 980900, 1002080, 1118750, 1073480, 1000800, 951605, 951257, 999477, 924796, 925869, 981673, 919962, 901299, 931228, 919071, 925841, 958229, 958575, 926909, 908967, 885213, 934758, 952853, 916530, 851220, 907156, 933305, 989105, 1028830, 1012620, 989542, 990320, 1076710, 1052980, 1012350, 1107310, 1085070, 978697, 1029110, 1043150, 1003880, 949739, 989609, 1013140, 996788, 943306, 1046230, 1053130, 1076870, 980069, 987705, 920967, 987589, 961524, 1008200, 1057810, 1008330, 974991, 1021420, 1157490, 1030600, 942102, 1028170, 987360, 954600, 989654, 917747, 923769, 929851, 938737, 895011, 876669, 892505, 937296, 924350, 912781, 886294, 955758, 982901, 1043890, 990342, 1011350, 980348, 911993, 919697, 942289, 959563, 934391, 893593, 907204, 888544, 910804, 897828, 976604, 977920, 920735, 904101, 926473, 990301, 953180, 966773, 994714, 993493, 1032650, 999983, 1019370, 1053600, 1039510, 1010700, 1010240, 1026710, 1028230, 1005490, 923863, 920597, 926926, 974065, 918617, 927330, 985345, 1086840, 1031020, 991636, 1012630, 1055750, 1096550, 986815, 1091470, 1086260, 1068980, 1062860, 1040270, 992451, 987612, 1014020, 1021230, 1136070, 1172160, 1129860, 1106270, 1036900, 1095930, 1186990, 1054110, 1158810, 1046160, 994351, 1101990, 1092320, 1044530, 960033, 918840, 987395, 1066400, 982441, 928592, 960780, 896348, 925189, 965135, 925724, 974362, 1017720, 1023130, 1024250, 1030470, 1128010, 1096480, 1071540, 998822, 1047750, 1061370, 1032190, 956697, 922413, 944484, 905652, 940572, 915004, 945004, 1029840, 1012460, 1018170, 1023910, 1014360, 1016300, 994442, 1060030, 1014240, 916018, 919013, 988701, 966103, 957699, 1002100, 1097620, 1043300, 1011790, 1049180, 1075640, 1125820, 1089890, 1023580, 984230, 970393, 991462, 984931, 1047890, 1045180, 971350, 962658, 1021320, 996769, 1029810, 995072, 1004200, 1015380, 1082530, 1074660, 1154290, 1094350, 1055360, 998099, 1015210, 1013640, 1021430, 1056220, 990610, 1013000, 940323, 969671, 977149, 984227, 982362, 922324, 965870, 958587, 1068950, 1161130, 1073450, 1073850, 1082910, 1060390, 1168780, 1088430, 1102650, 982456, 966156, 991798, 927501, 960252, 887865, 900605, 840132, 828657, 851148, 861326, 899008, 955143, 1055640, 965411, 920160, 1064950, 1123080, 1115740, 1056320, 1013240, 983958, 932107, 960158, 1168480, 1122070, 1096760, 1104950, 1068580, 1055570, 1080770, 1103790, 1089300, 1014890, 1034610, 967010, 949775, 931059, 946874, 883717, 953816, 970687, 1012000, 938996, 936622, 850228, 955310, 1032900, 1105290, 1071330, 1150700, 1061170, 1037600, 1071490, 963410, 949743, 963418, 1019930, 1113530, 1122000, 1079020, 1065420, 1047560, 922358, 972944, 952422, 929798, 1001410, 998703, 1002770, 1034830, 1012960, 1012370, 1129070, 1044810, 1019050, 969205, 999760, 1060460, 1104080, 1135710, 1103140, 1075990, 1084540, 1057140, 1054140, 1046060, 1001620, 938888, 994049, 1002900, 988767, 1015650, 1029220, 1016080, 1006170, 974862, 972561, 907715, 928199, 986161, 971241, 1008100, 1015220, 984460, 988563, 957683, 950711, 1082450, 1056800, 1115010, 1035220, 1029490, 991989, 946573, 1009650, 1060710, 1111160, 1058910, 1055640, 1087170, 1113860, 1133280, 1122650, 1074160, 1170880, 1125320, 1085170, 995280, 884066, 1032410, 996987, 1087310, 1010670, 1004260, 880745, 877266, 1034170, 979197, 1035370, 1012980, 1022810, 1034440, 1066910, 1064890, 1091130, 1059980, 1125400, 973355, 1041290, 1045280, 980349, 1003910, 960489, 1016120, 1048660, 1061280, 1023120, 1013740, 1028510, 934197, 977106, 1010910, 974226, 999592, 1016860, 1000640, 968838, 1066050, 1045920, 1113590, 1079080, 969462, 879118, 859333, 931170, 938580, 954663, 970606, 973018, 924609, 1029510, 971422, 980267, 1007130, 1032420, 963185, 968172, 970539, 1010730, 1122460, 1149070, 1020690, 1164730, 1133950, 1128300, 1032840, 1018330, 978291, 985005, 1078870, 1034520, 977361, 1033450, 1025270, 1022820, 994107, 1011200, 1074010, 1086990, 1079740, 997302, 947589, 959942, 975855, 917922, 937980, 1019260, 959948, 1030240, 964607, 924129, 965493, 969548, 1027470, 965564, 966516, 1066540, 1146030, 1072730, 1045330, 1062070, 1124010, 1136570, 1153980, 1077630, 1068480, 1047670, 1054010, 1003980, 982350, 1002930, 1078800, 1125710, 1111880, 1053440, 897574, 910136, 924984, 957967, 935652, 1001440, 974576, 939863, 845919, 845795, 870493, 925525, 887373, 925044, 995181, 987828, 1031600, 983437, 1003520, 987036, 962174, 1019860, 984967, 972695, 970939, 1047050, 1003360, 1005790, 1033950, 1034090, 1027140), `1975` = c(966587, 988773, 1042640, 959999, 920967, 875749, 944869, 836007, 760039, 778192, 814742, 888108, 849139, 854042, 957840, 956493, 945975, 1016710, 869279, 890635, 897541, 874564, 1016640, 986818, 1058620, 1020340, 1040050, 946721, 949277, 964547, 1061710, 1033410, 1077700, 1137210, 1077610, 1039140, 937145, 995861, 1026000, 916410, 954072, 875442, 988608, 869492, 975802, 1019110, 1010570, 1061020, 981120, 1041600, 952909, 947016, 914116, 889206, 916478, 944269, 922300, 1013230, 1016510, 1061000, 1004800, 936990, 975019, 892228, 926590, 975252, 895590, 937841, 876505, 919371, 977340, 976491, 934076, 864679, 937892, 912936, 969459, 961873, 930433, 1000200, 947830, 898219, 909369, 948438, 937214, 942070, 932139, 996124, 1026210, 1085300, 1089400, 1075150, 968934, 1054580, 1021980, 1004440, 948859, 955593, 967205, 907881, 782210, 946444, 974802, 943667, 964969, 931792, 955692, 995296, 968898, 949707, 961055, 1020750, 1018800, 1038270, 1006620, 1014240, 972120, 1020550, 946199, 964418, 886123, 926869, 956507, 911644, 847127, 910396, 883056, 1012900, 993313, 990502, 986693, 944976, 955811, 1003620, 1079180, 1137800, 1058170, 1140970, 1006790, 1009470, 916380, 951437, 973744, 955155, 950187, 941283, 937494, 949679, 987301, 1056780, 1089500, 1080340, 1169160, 1027930, 1024860, 1042400, 1027810, 954476, 977127, 1087630, 1006330, 1056130, 1129540, 1044090, 991579, 1003440, 1028310, 994648, 968579, 997672, 959803, 913295, 986418, 957485, 853232, 835840, 822460, 855833, 869915, 872740, 914687, 834121, 885838, 974500, 972887, 1022290, 924000, 936598, 971121, 945510, 910374, 883793, 982995, 1028790, 993647, 912690, 928445, 990985, 1026480, 1055030, 1088080, 1111170, 1043790, 996637, 995082, 986830, 969103, 878510, 918256, 939212, 879048, 935352, 948814, 987876, 991000, 1013680, 941149, 903443, 991087, 1085420, 1037400, 1061700, 1036320, 941512, 1061540, 1011840, 978132, 925905, 985422, 1014540, 991624, 880395, 910994, 941523, 914396, 965149, 1049080, 1094250, 974949, 1073170, 951410, 1014440, 1043790, 987670, 957852, 1067920, 1005370, 971266, 971223, 946739, 982056, 1065620, 1073250, 1072970, 1061480, 1055720, 1050210, 1017880, 1044770, 1031830, 1011950, 1086450, 1093980, 1070160, 968324, 948779, 902932, 982823, 955854, 864401, 897986, 951949, 956234, 980481, 998921, 927904, 906595, 892688, 918040, 902662, 935388, 953740, 914287, 806466, 923801, 1101450, 1007410, 1022100, 980793, 1028950, 971797, 974243, 918910, 920682, 956230, 910860, 1014560, 980075, 985116, 929066, 896089, 990698, 986425, 992567, 997312, 975737, 973438, 929863, 874028, 860727, 904070, 955575, 920169, 967528, 954614, 974132, 931353, 868910, 883290, 862944, 938092, 1002640, 1026780, 1099680, 990182, 1055380, 1063560, 1039200, 978777, 928724, 955447, 1034410, 917461, 834290, 866353, 887521, 858046, 900962, 907201, 1032250, 1004610, 941834, 970889, 992015, 927802, 957368, 1038040, 1002950, 952573, 974806, 1012340, 952776, 938809, 939969, 1000220, 878715, 840133, 882285, 829492, 886999, 905894, 870394, 928046, 1063930, 1121450, 1042240, 1062000, 1085560, 973862, 1020260, 1039150, 954690, 923438, 999874, 1020520, 992505, 956444, 989110, 912253, 906316, 948635, 967809, 1014500, 1058140, 1012040, 993807, 1004680, 993264, 994105, 1035320, 1007260, 975385, 1069130, 1007910, 975192, 912976, 995934, 916487, 952101, 919875, 1052860, 1024870, 1026050, 1003390, 1019660, 948459, 974895, 873023, 875171, 883804, 939169, 999686, 1011890, 991043, 952863, 887280, 940744, 951743, 1012290, 1018940, 1057310, 994224, 888083, 993918, 1025620, 959098, 951246, 834669, 892933, 969325, 1010620, 1031280, 1080610, 1080200, 1118670, 1069420, 981692, 1035240, 1023600, 1051160, 1056920, 993994, 1054030, 1069300, 999768, 1074690, 1099740, 998164, 1009600, 982823, 982535, 967468, 905637, 835977, 862924, 848973, 892594, 859730, 939136, 927956, 995769, 1064560, 923209, 957016, 826494, 854271, 915006, 932611, 884064, 930959, 946886, 931266, 932600, 896739, 948188, 1013810, 1062630, 996740, 970817, 1099900, 1015630, 941130, 917726, 899574, 934906, 857940, 838848, 898491, 885239, 860096, 922311, 900242, 903935, 929918, 917105, 858841, 826913, 846387, 940222, 949692, 920039, 841000, 891284, 952056, 986607, 995667, 972893, 990668, 967162, 1054110, 1037970, 948778, 1042710, 1021990, 887424, 944912, 978538, 939764, 931653, 959059, 978984, 933042, 863135, 974366, 975773, 1006400, 966816, 965460, 863785, 936416, 935355, 963042, 982960, 944821, 909270, 1017750, 1135680, 992042, 883374, 994977, 976114, 922767, 959493, 868374, 897281, 867650, 910287, 860094, 814777, 832774, 895058, 909143, 882583, 909046, 943221, 948933, 977034, 934714, 956398, 966482, 984294, 970082, 970879, 971742, 901685, 870471, 903662, 862200, 891998, 844142, 925413, 948351, 883794, 877781, 916887, 954036, 979170, 938086, 962365, 1030980, 987534, 960249, 1022590, 1048980, 1056100, 1038690, 1029330, 1040990, 1068740, 988493, 878453, 867800, 906495, 980442, 988145, 951693, 976642, 1083160, 1017800, 1013400, 1027660, 1062790, 1086130, 1010870, 1097900, 1023710, 997735, 1010110, 981402, 951647, 972949, 994813, 983120, 1093500, 1107500, 1056130, 1032260, 997428, 1108380, 1172440, 1043010, 1128510, 1030940, 980936, 1088360, 1057830, 1000310, 894824, 887756, 976228, 1029150, 987349, 941484, 957845, 932278, 941031, 939782, 926449, 918285, 974614, 928306, 930423, 977312, 1039700, 1013250, 1029680, 980408, 1005820, 1032670, 1044270, 998884, 956280, 950252, 880285, 969347, 858241, 934704, 990657, 971575, 955853, 974926, 1016240, 1019760, 977838, 1044050, 990542, 906416, 930523, 1025090, 994170, 943605, 978371, 1060980, 1058890, 985668, 989261, 1005960, 1099930, 1056750, 1015340, 978501, 970213, 983329, 950846, 1000170, 1021650, 932609, 886375, 904734, 902505, 974769, 902999, 920381, 930596, 980446, 1044390, 1139040, 1091690, 1028370, 964869, 1026280, 1026190, 1034260, 1013640, 930548, 965401, 909964, 921759, 910250, 936674, 895191, 877710, 877981, 899508, 1046240, 1143160, 1027460, 1012300, 1003030, 1016400, 1087020, 1008080, 1038730, 926365, 925692, 991374, 919504, 910873, 792930, 810704, 751506, 757967, 860432, 887181, 900414, 952570, 1083430, 963169, 946249, 1038710, 1039350, 1054400, 1000990, 982131, 995551, 901653, 932528, 1122940, 1056030, 1050780, 1076750, 1004850, 1006670, 1062090, 1102740, 1152280, 1017490, 1047730, 940872, 1008180, 950180, 931111, 840307, 888078, 948996, 996250, 925031, 945284, 886733, 948436, 1066150, 1105270, 1058500, 1119710, 1013950, 986182, 996110, 855408, 893087, 911687, 941297, 1048480, 1063760, 1061610, 1059490, 1067560, 889024, 974369, 916023, 930484, 1025850, 1008400, 957908, 993847, 968521, 933105, 1084530, 959594, 947895, 922025, 934937, 961948, 1010850, 1028100, 1030220, 1024390, 1079200, 1062280, 1046800, 1014150, 957200, 872886, 944506, 927933, 926276, 963499, 999917, 994725, 956530, 923239, 920850, 904246, 867141, 969277, 944346, 1007090, 1041770, 1027190, 985287, 933693, 949447, 1105270, 1097080, 1092690, 1006490, 1019830, 1015820, 980299, 990540, 1069230, 1127920, 1075670, 1063880, 1073190, 1068020, 1107450, 1047780, 1021830, 1080240, 1052450, 982737, 884894, 845683, 971171, 963191, 1035310, 954222, 981737, 892476, 880705, 1008670, 947222, 1016570, 999137, 986673, 1015630, 1003660, 960581, 1035870, 996768, 1045570, 907447, 988172, 1043950, 1016080, 1052410, 1000450, 1011230, 1056770, 1096900, 999885, 1010340, 1000530, 881462, 941097, 954611, 912920, 915022, 948529, 928116, 879960, 946523, 970872, 1083030, 1039480, 952363, 852782, 813064, 898275, 883383, 915801, 932967, 943083, 850490, 998435, 902098, 937385, 981373, 982389, 910366, 907120, 875831, 944583, 1031880, 1075470, 930537, 1075530, 1083650, 1084890, 1016540, 985735, 962179, 978047, 1057610, 979862, 906222, 945584, 963825, 969843, 890373, 942834, 961082, 1031980, 1042010, 958657, 922858, 908750, 970665, 911914, 895262, 949258, 911928, 1019870, 978961, 918063, 964483, 945434, 958645, 920900, 905925, 963121, 1025650, 978444, 1007860, 1032290, 1111370, 1149180, 1148310, 1091470, 1088120, 1058970, 1074240, 1049750, 1003190, 989293, 1057370, 1100780, 1078040, 993458, 839899, 851168, 838979, 866029, 851665, 922640, 964697, 899847, 832722, 829177, 869572, 932359, 924616, 918377, 956781, 932614, 1034740, 1008210, 991867, 962399, 955319, 993504, 1019290, 1076050, 943378, 1004170, 959738, 953161, 930740, 946687, 970813), `1976` = c(1060740, 1095260, 1127030, 1013680, 986850, 917600, 1029430, 965213, 867689, 924276, 919139, 982556, 1002340, 979036, 1023990, 1011810, 1043000, 1081910, 1005040, 976835, 1005480, 1008780, 1156250, 1093360, 1134710, 1102430, 1131740, 1004670, 1013930, 1067420, 1112390, 1086440, 1162900, 1201560, 1170750, 1150340, 1073610, 1085400, 1176550, 1056860, 1025740, 1006900, 1037130, 962929, 1098380, 1151100, 1102150, 1213020, 1142190, 1152580, 1086780, 1066660, 1012060, 1045240, 1093020, 1051150, 1010860, 1116690, 1068640, 1077970, 1037620, 1037380, 1100560, 993931, 1044030, 1123850, 1044450, 1110420, 990704, 994531, 1043310, 958931, 939361, 909767, 976063, 939861, 1001670, 991718, 980761, 1041790, 1011280, 1010880, 1014140, 1094990, 1112700, 1071290, 1025210, 1031690, 1033050, 1130530, 1128940, 1111760, 1068820, 1135380, 1098720, 1139100, 1142730, 1115620, 1014850, 943443, 841291, 994408, 1028540, 1039050, 1072890, 1030720, 1039930, 1046910, 1003910, 975945, 967593, 1068500, 1091690, 1164160, 1117790, 1111380, 1047920, 1067700, 1030450, 1050370, 974469, 976386, 998494, 1005510, 974057, 1037560, 978282, 1105300, 1156200, 1099680, 1062320, 1092090, 1051650, 1069070, 1100890, 1155180, 1114060, 1214570, 1128130, 1148140, 1005640, 1062540, 1083840, 1089070, 1028060, 1000440, 983352, 987419, 1051870, 1176470, 1197390, 1173910, 1250220, 1222390, 1184520, 1159490, 1119170, 1062050, 1103150, 1185700, 1156070, 1180140, 1219720, 1133780, 1090420, 1131090, 1135930, 1047490, 1071760, 1147910, 1105710, 1061350, 1080290, 1092520, 1026070, 984719, 931546, 1017450, 1019240, 1043540, 1069550, 1043930, 1031730, 1103430, 1080760, 1101710, 1047840, 1072080, 1065780, 1072280, 1029940, 997967, 1078430, 1095220, 987254, 900929, 969187, 1086050, 1103240, 1143330, 1157270, 1153100, 1064690, 1016320, 1062890, 1108830, 1068690, 1014160, 1052860, 1072100, 1037710, 1084710, 1095990, 1132550, 1089700, 1078400, 1095730, 1083340, 1122470, 1177680, 1117810, 1170750, 1143540, 1053630, 1168110, 1152150, 1141960, 1041740, 1056100, 1073170, 1031520, 952862, 1015780, 1004690, 988580, 1053700, 1116410, 1186520, 1087600, 1216210, 1114270, 1173170, 1158010, 1091150, 1097530, 1202870, 1096270, 1016830, 1042580, 1043120, 1037620, 1121680, 1148740, 1143080, 1146460, 1170830, 1165710, 1135550, 1173220, 1217650, 1179530, 1203330, 1222240, 1244290, 1162560, 1117320, 1038410, 1085980, 1144550, 1047230, 1027220, 1057780, 1036090, 1095740, 1121730, 1031790, 1049240, 983251, 1010730, 1027710, 1054820, 1067120, 1020110, 898707, 1055200, 1183220, 1079320, 1112880, 1034800, 1059230, 1003320, 1059440, 1002330, 1015120, 1056020, 1014050, 1125480, 1059450, 1063940, 1052630, 1011270, 1047610, 1071740, 1088640, 1115720, 1052900, 1055610, 1076890, 1040250, 1078010, 1082240, 1059890, 1014460, 1024210, 1028240, 1035710, 1018550, 960067, 980431, 961488, 1014700, 1129020, 1130650, 1203550, 1118860, 1166820, 1188350, 1187390, 1115230, 1036740, 1087540, 1099350, 1001540, 939909, 969710, 969563, 958122, 987715, 978738, 1071370, 1076240, 1032330, 1074150, 1113750, 1074290, 1126480, 1192710, 1138110, 1122410, 1150610, 1139330, 1077060, 1086790, 1084250, 1112350, 984538, 886638, 924142, 941064, 978894, 1000350, 1011700, 1026750, 1136870, 1153690, 1089570, 1060690, 1122430, 1037790, 1055700, 1088160, 977831, 968613, 1076240, 1085920, 1080080, 1044840, 1029400, 1009140, 1014590, 1043330, 1082280, 1129350, 1150360, 1032440, 1010130, 1081160, 1087040, 1103550, 1124220, 1054360, 1067300, 1131690, 1106270, 1065440, 990886, 1094220, 1000210, 1033090, 1077710, 1182470, 1143520, 1092930, 1052240, 1078450, 1049600, 1071390, 1009330, 1003330, 1037330, 1091330, 1132170, 1095310, 1090770, 1080370, 1053110, 1083520, 1099090, 1172350, 1188680, 1152620, 1128620, 1064450, 1172510, 1164180, 1098590, 1065860, 1044290, 1011360, 1056060, 1054740, 1087260, 1163360, 1138750, 1231110, 1179060, 1131690, 1165370, 1126150, 1208670, 1165290, 1089820, 1218630, 1221230, 1144490, 1220720, 1193200, 1078940, 1105920, 1105410, 1094370, 1072750, 1066580, 964937, 976997, 961443, 973548, 977645, 1054820, 1030670, 1038340, 1134030, 968692, 996839, 877901, 896151, 982166, 1025660, 1025980, 1056380, 1027780, 975747, 1022740, 1018340, 1032070, 1107830, 1147180, 1130620, 1113300, 1276240, 1089570, 1086400, 1051980, 988284, 1021940, 947738, 967321, 1069630, 1048830, 1037400, 1068080, 1070730, 1065090, 1062360, 1045820, 1011230, 1012550, 1000700, 1106930, 1069230, 1015130, 947039, 1056030, 1094300, 1103730, 1062490, 1038070, 1029570, 1080230, 1123260, 1127550, 1059720, 1109490, 1091320, 957216, 985476, 1002520, 932659, 976871, 1041290, 1056420, 989331, 963469, 1091820, 1115780, 1105020, 1091800, 1052690, 946277, 971523, 1034990, 1084820, 1118600, 1111160, 1082240, 1138880, 1245710, 1070710, 987250, 1048480, 1072110, 971231, 1043660, 1000680, 1003600, 992097, 1013180, 987490, 984921, 1010150, 1058020, 1086020, 1055150, 1111240, 1131660, 1111840, 1098750, 1091030, 1145510, 1123050, 1091710, 1099400, 1091140, 1080940, 1032620, 1004510, 1012130, 981196, 1001130, 891149, 988781, 982854, 934770, 963741, 988930, 1062030, 1125500, 1044410, 1048820, 1138680, 1108100, 1089330, 1100070, 1081450, 1094460, 1038960, 1059260, 1136410, 1158860, 1073120, 928725, 893709, 954109, 1011550, 1034540, 983429, 1010140, 1108900, 1078590, 1091040, 1086790, 1109200, 1145160, 1068350, 1136060, 1083000, 1082650, 1134850, 1057640, 1041920, 1104580, 1139520, 1145890, 1225580, 1216490, 1174720, 1152990, 1128070, 1231480, 1282980, 1114880, 1209130, 1097970, 1120140, 1271200, 1174370, 1115180, 990720, 1002330, 1088020, 1147740, 1139020, 1043620, 1054300, 1067440, 1014650, 988570, 981550, 979868, 1001010, 950765, 996920, 1067790, 1153700, 1093070, 1073340, 1043650, 1124920, 1170940, 1138600, 1125900, 1098860, 1077870, 1018110, 1103290, 969781, 1002360, 1077910, 1081100, 1027300, 1103540, 1107570, 1106050, 1144630, 1178910, 1109390, 990046, 1027270, 1132910, 1062840, 1011300, 1065940, 1150510, 1150020, 1106750, 1084980, 1077310, 1164620, 1099770, 1054360, 1062650, 1046330, 1081930, 1027960, 1076840, 1114650, 1024770, 1026690, 1066490, 1013420, 1091640, 1021770, 1005500, 963001, 1010520, 1084330, 1238550, 1217250, 1065370, 1045170, 1124070, 1122470, 1107140, 1097200, 1040740, 1031200, 1026350, 1038270, 1055050, 1085960, 1035060, 999638, 1000920, 1013070, 1095580, 1202900, 1110150, 1054970, 1007640, 1033690, 1171100, 1060830, 1126720, 1001050, 1017040, 1153590, 1141060, 1072680, 986571, 985259, 964299, 988311, 1048660, 1068920, 1047420, 1034230, 1168340, 1081700, 1057990, 1127860, 1103110, 1072520, 1025050, 1011440, 1069710, 1022650, 1065030, 1185760, 1126180, 1103420, 1076670, 981181, 987297, 1060780, 1095580, 1168940, 1013120, 1091830, 1018490, 1065500, 1031500, 1049490, 966290, 993030, 1039430, 1088290, 1013980, 1048180, 1038480, 1051140, 1171710, 1223940, 1135010, 1221300, 1089870, 1036570, 1060200, 925543, 987761, 1001000, 992822, 1056610, 1109010, 1141670, 1072630, 1101500, 958381, 1064620, 1056840, 1031490, 1104320, 1041640, 994998, 1081470, 1094380, 1046370, 1136780, 1063180, 1025880, 1014920, 1018620, 1032380, 1081080, 1134700, 1100600, 1117600, 1167850, 1159100, 1147600, 1103070, 1063830, 1013170, 1048870, 1015930, 992141, 1035130, 1068230, 1078500, 1049430, 1061830, 1058000, 1051540, 1017660, 1110690, 1025000, 1075870, 1131870, 1085810, 1054820, 1029910, 993095, 1146650, 1111640, 1066600, 1029280, 1084420, 1110060, 1070390, 1100910, 1141020, 1205330, 1205820, 1166230, 1159320, 1167180, 1195670, 1155210, 1110690, 1190480, 1165690, 1089510, 1005470, 975294, 1045590, 1012140, 1063050, 981521, 1046780, 991727, 1005570, 1060220, 985293, 1081410, 1125370, 1129090, 1112340, 1122470, 1065390, 1119040, 1043950, 1084400, 931390, 1011010, 1083720, 1043220, 1073240, 1105320, 1066280, 1119280, 1147990, 1042500, 1091200, 1071210, 936812, 1000760, 1036320, 983198, 948158, 1014940, 977931, 932711, 1031660, 1088810, 1179040, 1161910, 1074450, 1021410, 971389, 1021690, 1020180, 1077330, 1080060, 1092060, 1016610, 1112140, 1004690, 1012220, 1073030, 1085070, 988462, 1088160, 1045500, 1121940, 1132490, 1150430, 1020370, 1130040, 1118960, 1106190, 1081670, 1029880, 1036240, 1051330, 1113550, 1043830, 968403, 976298, 1003130, 1026470, 920285, 979221, 1012920, 1105380, 1108150, 1019440, 998654, 986338, 1039450, 994854, 1010750, 1041590, 977093, 1046790, 1054170, 997688, 1054160, 1019270, 1031810, 999831, 1003600, 1105200, 1130010, 1095660, 1072930, 1094400, 1130490, 1188670, 1199130, 1107100, 1124220, 1077830, 1089570, 1093690, 1069190, 1058980, 1150640, 1196230, 1175440, 1082730, 957145, 1005240, 1064810, 972620, 965958, 1024050, 1058170, 1000800, 968970, 952886, 924236, 973878, 989496, 996901, 1064180, 1044060, 1141980, 1086590, 1074340, 1023120, 993021, 1038140, 1082710, 1135110, 1003590, 1121430, 1150540, 1101520, 1050860, 1100880, 1089720), `1977` = c(1483290, 1477630, 1545220, 1389070, 1441370, 1368490, 1501270, 1434610, 1309340, 1306780, 1320670, 1341870, 1439160, 1324210, 1388110, 1371630, 1464140, 1529890, 1415010, 1439450, 1512640, 1456500, 1555900, 1485740, 1502850, 1478330, 1566910, 1488240, 1511030, 1546950, 1586090, 1561690, 1621130, 1602630, 1546550, 1595030, 1499440, 1501520, 1587550, 1544350, 1511570, 1451620, 1455070, 1415990, 1540210, 1606280, 1564400, 1632570, 1544030, 1540890, 1435000, 1476620, 1459430, 1440620, 1484520, 1482630, 1471510, 1462930, 1423240, 1450790, 1445880, 1500940, 1520370, 1519220, 1584090, 1631780, 1542960, 1555670, 1434370, 1444020, 1466300, 1364000, 1373100, 1371250, 1316240, 1373150, 1427290, 1469380, 1435780, 1403090, 1375590, 1474180, 1463340, 1515880, 1537920, 1596620, 1508490, 1564610, 1479460, 1570130, 1571140, 1622460, 1633480, 1669030, 1615060, 1617070, 1604200, 1549870, 1486570, 1398360, 1339000, 1464270, 1461690, 1473550, 1535250, 1475030, 1435970, 1382420, 1374080, 1370970, 1360640, 1510900, 1520180, 1568610, 1494320, 1523420, 1457880, 1429780, 1524840, 1503600, 1468020, 1432730, 1409210, 1432130, 1435800, 1468080, 1469390, 1503800, 1587880, 1506600, 1484200, 1468620, 1454420, 1459300, 1498900, 1596140, 1625350, 1674850, 1556960, 1538700, 1393030, 1450090, 1424000, 1469910, 1406700, 1422420, 1488560, 1449120, 1482560, 1584860, 1577950, 1540320, 1610270, 1594310, 1676880, 1584910, 1499360, 1453050, 1471390, 1600050, 1532260, 1568450, 1543860, 1448350, 1400770, 1521140, 1529440, 1459230, 1494520, 1589900, 1520980, 1394550, 1443690, 1490550, 1467820, 1374130, 1344640, 1401780, 1388480, 1385890, 1446080, 1374320, 1367180, 1447260, 1459310, 1507740, 1405160, 1497430, 1488760, 1491710, 1443290, 1433400, 1522730, 1547580, 1428720, 1359360, 1430230, 1507910, 1493250, 1509290, 1607640, 1620690, 1561340, 1499280, 1489560, 1502880, 1463070, 1471820, 1484070, 1490800, 1440040, 1542590, 1540200, 1504640, 1469660, 1477890, 1555090, 1559020, 1562580, 1632750, 1596990, 1589810, 1539780, 1482800, 1522840, 1514420, 1535980, 1438590, 1420110, 1430380, 1442220, 1451470, 1457250, 1449610, 1477560, 1508730, 1541980, 1591450, 1459140, 1649810, 1537770, 1585220, 1596050, 1547960, 1526430, 1611810, 1510200, 1433740, 1455630, 1443750, 1450830, 1470260, 1475490, 1488470, 1568120, 1617650, 1556120, 1514190, 1548000, 1612260, 1539890, 1566770, 1538330, 1572600, 1479420, 1508790, 1480190, 1504300, 1581160, 1486190, 1476390, 1493250, 1421080, 1510310, 1537860, 1426800, 1458910, 1412140, 1495060, 1551640, 1522020, 1529940, 1552000, 1474480, 1564190, 1578360, 1478190, 1483120, 1413090, 1430110, 1387530, 1444830, 1386410, 1398000, 1531170, 1472400, 1591610, 1565870, 1569580, 1546920, 1421350, 1437840, 1503860, 1488740, 1503220, 1498150, 1405500, 1438140, 1421900, 1497570, 1480920, 1402110, 1356570, 1398440, 1402620, 1392160, 1415830, 1374220, 1385870, 1389600, 1465130, 1530950, 1646630, 1607070, 1576860, 1585900, 1583280, 1605580, 1472040, 1426150, 1529530, 1543080, 1511870, 1478440, 1465700, 1498750, 1351280, 1433740, 1439640, 1521850, 1546760, 1542680, 1592770, 1592040, 1498570, 1485270, 1545430, 1483990, 1476980, 1506130, 1497940, 1433930, 1460620, 1536620, 1513040, 1443410, 1419660, 1493550, 1532630, 1456070, 1445160, 1490570, 1551170, 1615170, 1582000, 1521500, 1470480, 1475040, 1437210, 1493730, 1481080, 1359150, 1407980, 1514220, 1495050, 1502920, 1441430, 1406700, 1365400, 1416420, 1443660, 1510370, 1568370, 1608690, 1490460, 1433160, 1499860, 1468000, 1467920, 1475240, 1424140, 1501760, 1510210, 1556910, 1515830, 1459050, 1517790, 1384450, 1352470, 1442030, 1525490, 1458470, 1388550, 1437700, 1442150, 1449790, 1505550, 1461240, 1457340, 1545310, 1555050, 1530290, 1439810, 1464040, 1486990, 1464490, 1509300, 1510320, 1550360, 1586330, 1632490, 1604200, 1541760, 1590210, 1535070, 1518400, 1502540, 1496350, 1442120, 1489570, 1465810, 1537090, 1563060, 1550230, 1625950, 1617230, 1530390, 1545740, 1517170, 1554590, 1565830, 1470360, 1593970, 1623470, 1517940, 1574370, 1572720, 1423140, 1484980, 1545120, 1566920, 1550540, 1526130, 1398300, 1426440, 1407080, 1401950, 1475930, 1523060, 1540850, 1430260, 1509680, 1428630, 1453820, 1390470, 1409430, 1493850, 1471880, 1472460, 1525560, 1439380, 1407110, 1446540, 1448870, 1431260, 1461380, 1528490, 1548150, 1496330, 1665630, 1500550, 1546870, 1537160, 1443950, 1471870, 1437670, 1440150, 1499830, 1521400, 1502530, 1525680, 1572540, 1558380, 1512350, 1489420, 1482950, 1406500, 1424610, 1502690, 1491540, 1441910, 1360240, 1465130, 1435440, 1415190, 1386710, 1364410, 1413920, 1520010, 1562580, 1550970, 1481570, 1513360, 1493450, 1335330, 1382300, 1380820, 1295850, 1322180, 1376780, 1378930, 1337200, 1293620, 1425120, 1422890, 1398170, 1442550, 1447510, 1300390, 1323210, 1488890, 1521610, 1563060, 1573460, 1546410, 1507860, 1587660, 1426830, 1399520, 1436270, 1416610, 1381770, 1424070, 1440630, 1410890, 1377570, 1469100, 1478640, 1517050, 1482590, 1483580, 1557740, 1488360, 1538760, 1533820, 1497630, 1494250, 1500140, 1559600, 1510690, 1465840, 1459920, 1467530, 1433110, 1456970, 1456510, 1399020, 1358850, 1424070, 1308450, 1419750, 1358330, 1323760, 1451880, 1476080, 1538790, 1552560, 1482320, 1501700, 1534570, 1493450, 1512890, 1523250, 1458110, 1475260, 1411890, 1442960, 1492660, 1541820, 1527810, 1357500, 1391950, 1460720, 1539480, 1527800, 1494220, 1418590, 1438710, 1438660, 1418400, 1425030, 1484290, 1508600, 1426840, 1499540, 1520950, 1560660, 1597740, 1546480, 1525650, 1517740, 1608840, 1572850, 1595960, 1610410, 1574300, 1478160, 1423360, 1536090, 1601650, 1485550, 1655630, 1497380, 1512080, 1675670, 1519950, 1473400, 1380090, 1387610, 1491450, 1504290, 1591260, 1552130, 1447970, 1564560, 1474650, 1452480, 1417300, 1351960, 1474350, 1429810, 1443960, 1488760, 1547270, 1511110, 1537670, 1470650, 1537320, 1601180, 1582070, 1535480, 1520270, 1508600, 1401750, 1491670, 1404750, 1388250, 1462050, 1489480, 1404010, 1477890, 1438510, 1554900, 1541900, 1524330, 1509890, 1394150, 1459590, 1540170, 1480660, 1401220, 1456460, 1546140, 1541110, 1473510, 1474630, 1472980, 1488140, 1502650, 1518480, 1557240, 1537280, 1575230, 1539930, 1588480, 1570050, 1498400, 1508510, 1520280, 1478290, 1538020, 1517260, 1452260, 1398980, 1450740, 1529160, 1616250, 1648920, 1466780, 1445130, 1461020, 1477790, 1508050, 1502710, 1448810, 1456660, 1438330, 1558340, 1498550, 1594480, 1532220, 1465200, 1507870, 1522330, 1594120, 1606230, 1472720, 1436260, 1466610, 1497630, 1612970, 1503530, 1555520, 1377850, 1387060, 1515340, 1511710, 1442430, 1454450, 1396820, 1410760, 1462980, 1514120, 1594420, 1493670, 1504030, 1575780, 1515620, 1496900, 1525050, 1526710, 1508090, 1466850, 1453090, 1506630, 1515380, 1530610, 1663150, 1611510, 1613880, 1610150, 1466910, 1517140, 1551950, 1584390, 1614580, 1487630, 1543160, 1549490, 1541770, 1502020, 1516960, 1481400, 1455100, 1458820, 1446280, 1378230, 1454280, 1510890, 1554030, 1676340, 1669990, 1540100, 1696130, 1567080, 1491360, 1518340, 1433550, 1457470, 1367270, 1327680, 1378260, 1480020, 1543970, 1490350, 1556830, 1465270, 1502800, 1475710, 1437120, 1540730, 1483100, 1413560, 1445670, 1451060, 1443380, 1585150, 1472570, 1439570, 1410050, 1391720, 1415390, 1482720, 1491480, 1473110, 1523970, 1515220, 1598050, 1539360, 1538360, 1523040, 1566350, 1620640, 1535600, 1477740, 1496830, 1532300, 1521150, 1465880, 1526540, 1495270, 1461550, 1432050, 1518090, 1430360, 1417080, 1482940, 1421860, 1492410, 1474160, 1408950, 1548830, 1536470, 1417060, 1420050, 1479310, 1507390, 1443270, 1453710, 1432540, 1493190, 1495630, 1483650, 1470550, 1516070, 1514370, 1523800, 1569870, 1625330, 1619530, 1598740, 1520060, 1422140, 1478000, 1507990, 1528260, 1440190, 1515300, 1447860, 1486600, 1486140, 1421580, 1518020, 1499100, 1491520, 1436250, 1498340, 1529430, 1510720, 1377470, 1481790, 1425580, 1474800, 1486960, 1489620, 1426270, 1405420, 1448210, 1524600, 1569860, 1458040, 1464600, 1453270, 1333090, 1356950, 1461000, 1442930, 1398660, 1465280, 1442340, 1466250, 1568900, 1569500, 1611150, 1549310, 1511590, 1475730, 1450670, 1465400, 1486010, 1524150, 1492610, 1532050, 1452160, 1517140, 1420100, 1390190, 1429340, 1457370, 1421450, 1488220, 1471590, 1550230, 1578610, 1565630, 1425200, 1484710, 1477250, 1514160, 1481320, 1459780, 1495220, 1509940, 1548510, 1481340, 1367330, 1404460, 1394430, 1399140, 1306580, 1339100, 1299780, 1376130, 1422430, 1361970, 1369770, 1409420, 1447590, 1472300, 1495880, 1550290, 1482130, 1487060, 1591540, 1488500, 1503030, 1516740, 1508740, 1509040, 1550840, 1581330, 1564700, 1490260, 1489270, 1541440, 1543620, 1628530, 1590490, 1468520, 1526010, 1489090, 1467000, 1456780, 1479920, 1469370, 1555830, 1622390, 1555710, 1453530, 1365280, 1411540, 1440800, 1360180, 1381720, 1401330, 1420390, 1382570, 1360230, 1369760, 1320450, 1339110, 1316390, 1333620, 1412410, 1374290, 1472960, 1402070, 1388700, 1387760, 1349240, 1377970, 1480630, 1552950, 1450430, 1579190, 1629050, 1555200, 1446580, 1553020, 1517110), `1978` = c(1503230, 1520800, 1582290, 1438950, 1456700, 1461020, 1577090, 1475100, 1318750, 1326820, 1341480, 1409880, 1472440, 1321510, 1340930, 1338290, 1473280, 1501320, 1418280, 1450120, 1545980, 1455240, 1592610, 1523480, 1518220, 1463270, 1567300, 1493290, 1561170, 1605470, 1610210, 1556830, 1651300, 1626200, 1563470, 1592840, 1511260, 1535760, 1616890, 1574420, 1567340, 1544140, 1529430, 1468610, 1519510, 1589220, 1576920, 1652930, 1547520, 1500590, 1429090, 1549140, 1577460, 1475710, 1525700, 1545460, 1520300, 1537140, 1463740, 1475450, 1476880, 1565790, 1528900, 1564900, 1590570, 1599580, 1497390, 1532930, 1490970, 1529480, 1533400, 1467160, 1450690, 1417450, 1328660, 1405620, 1436950, 1505150, 1455610, 1421970, 1329480, 1471700, 1459790, 1537880, 1553940, 1626000, 1526620, 1573960, 1486940, 1520130, 1560930, 1608680, 1654470, 1662940, 1603810, 1595660, 1603450, 1536850, 1464020, 1383400, 1393400, 1486260, 1490610, 1471400, 1526580, 1488920, 1435600, 1376410, 1367410, 1375150, 1342060, 1534500, 1579850, 1595680, 1479400, 1520930, 1482230, 1418220, 1599790, 1586330, 1515730, 1501470, 1471420, 1463330, 1460270, 1485740, 1493850, 1459550, 1563710, 1521110, 1531660, 1484010, 1487590, 1452320, 1537750, 1615000, 1643980, 1628170, 1539960, 1531900, 1410500, 1482020, 1462530, 1465960, 1420800, 1404160, 1493320, 1422470, 1492470, 1563680, 1580220, 1562210, 1686290, 1640710, 1694010, 1630020, 1509980, 1466020, 1545970, 1641250, 1600200, 1630630, 1571970, 1530340, 1458990, 1588600, 1571570, 1463090, 1490980, 1614470, 1556570, 1423540, 1458500, 1505510, 1529590, 1398120, 1380600, 1464050, 1417820, 1393090, 1507080, 1482010, 1407710, 1510950, 1501440, 1550050, 1459090, 1515600, 1510460, 1506030, 1459730, 1465380, 1548200, 1587750, 1445670, 1347260, 1420720, 1540960, 1528500, 1513410, 1610860, 1610650, 1556290, 1489850, 1477590, 1513500, 1432780, 1502950, 1470440, 1482680, 1478580, 1569830, 1571950, 1563780, 1549560, 1542500, 1629880, 1606010, 1576410, 1634190, 1619750, 1594910, 1535610, 1442040, 1470270, 1453880, 1501850, 1434210, 1392940, 1416370, 1408720, 1439640, 1447670, 1435700, 1508690, 1516300, 1547730, 1639610, 1492060, 1700440, 1540650, 1606990, 1592570, 1563840, 1524860, 1601040, 1509980, 1461420, 1483880, 1492140, 1485530, 1517010, 1440620, 1463800, 1612160, 1650400, 1570630, 1570580, 1587550, 1643610, 1525960, 1566840, 1500120, 1561900, 1536780, 1586830, 1570120, 1541430, 1603770, 1489160, 1477650, 1489360, 1396970, 1524750, 1512880, 1380040, 1453460, 1382410, 1458880, 1550220, 1520150, 1547000, 1554030, 1472060, 1547400, 1557570, 1476150, 1490070, 1432020, 1441040, 1392240, 1462480, 1419020, 1443790, 1574260, 1542540, 1624820, 1574880, 1591540, 1532030, 1441060, 1439150, 1509800, 1495930, 1506020, 1506270, 1399300, 1531550, 1456210, 1559840, 1566060, 1481420, 1399420, 1441290, 1483440, 1415350, 1428380, 1400290, 1415340, 1409390, 1502070, 1527490, 1696540, 1647280, 1631560, 1607630, 1620080, 1628090, 1462700, 1450790, 1544110, 1585660, 1567280, 1569850, 1576540, 1526550, 1366410, 1444220, 1474200, 1544460, 1526750, 1514990, 1624740, 1621370, 1530330, 1512140, 1538250, 1496120, 1466270, 1492540, 1502970, 1399330, 1467390, 1547130, 1515520, 1451870, 1472470, 1501010, 1582740, 1493920, 1488870, 1547140, 1604560, 1634800, 1617280, 1563070, 1530340, 1540030, 1504820, 1561690, 1537330, 1395170, 1457230, 1507810, 1459280, 1454950, 1416560, 1404940, 1378860, 1420110, 1419820, 1519860, 1649300, 1673600, 1567030, 1505470, 1588720, 1569400, 1485480, 1515800, 1482590, 1593350, 1571110, 1627830, 1585310, 1536500, 1567830, 1465710, 1432050, 1566630, 1584760, 1493580, 1408900, 1480980, 1523700, 1513310, 1582660, 1525520, 1488730, 1537250, 1547110, 1524720, 1422500, 1472060, 1455630, 1474030, 1556850, 1569260, 1555310, 1579230, 1637710, 1628820, 1598880, 1666140, 1550130, 1554700, 1529630, 1552160, 1505320, 1513880, 1483420, 1548570, 1588000, 1603160, 1654830, 1638950, 1541410, 1527780, 1514600, 1554490, 1557030, 1452270, 1591700, 1623600, 1503410, 1548380, 1575110, 1457590, 1533590, 1587990, 1607340, 1578790, 1540880, 1457780, 1462720, 1452930, 1412730, 1498950, 1575610, 1544880, 1409020, 1508400, 1448190, 1475260, 1436100, 1428390, 1530300, 1549680, 1553300, 1551440, 1469570, 1425300, 1513040, 1524080, 1481870, 1480670, 1533060, 1533080, 1502180, 1672690, 1576270, 1584530, 1591200, 1459430, 1463990, 1453680, 1476380, 1508750, 1576600, 1507860, 1475610, 1545580, 1529030, 1505410, 1515870, 1501210, 1446280, 1486020, 1529270, 1520390, 1479580, 1404980, 1495450, 1432920, 1401780, 1357200, 1306730, 1349340, 1492970, 1554500, 1563320, 1511200, 1580490, 1506630, 1414160, 1406160, 1385530, 1340150, 1344800, 1396190, 1411020, 1383490, 1355120, 1429230, 1452080, 1425710, 1481770, 1489470, 1370140, 1409010, 1552160, 1563480, 1641990, 1639330, 1553780, 1492540, 1582470, 1469630, 1424640, 1470860, 1426280, 1448550, 1502910, 1468480, 1438000, 1423630, 1539010, 1548000, 1580430, 1541880, 1524750, 1615840, 1584720, 1593470, 1541270, 1522690, 1510930, 1509590, 1556980, 1562960, 1520180, 1529760, 1514860, 1498350, 1503160, 1501160, 1403310, 1352590, 1414610, 1304230, 1449720, 1408650, 1362690, 1502530, 1514650, 1592980, 1559220, 1483750, 1538100, 1564490, 1526220, 1543690, 1540270, 1468200, 1466480, 1426040, 1448920, 1495800, 1546500, 1548320, 1411060, 1466100, 1510090, 1604170, 1561220, 1526460, 1474630, 1517370, 1506190, 1446740, 1443430, 1494870, 1505800, 1423840, 1509800, 1588860, 1637080, 1729950, 1565590, 1580700, 1516070, 1609700, 1564230, 1620250, 1648760, 1572160, 1507790, 1433780, 1580280, 1661790, 1564030, 1716630, 1564810, 1533430, 1665880, 1537700, 1495280, 1439150, 1446320, 1513380, 1615870, 1704400, 1661870, 1561810, 1635750, 1532240, 1509770, 1444690, 1320930, 1478880, 1444890, 1458620, 1495420, 1556920, 1534830, 1552390, 1466740, 1536770, 1591870, 1598260, 1587320, 1559210, 1523880, 1416880, 1495470, 1421120, 1374670, 1428460, 1471170, 1440100, 1528740, 1457920, 1556710, 1540090, 1555290, 1561720, 1482820, 1491710, 1558910, 1528770, 1502040, 1510540, 1590160, 1603800, 1563330, 1533770, 1533220, 1488310, 1543430, 1572170, 1605210, 1554570, 1571920, 1574410, 1626520, 1578420, 1506320, 1518040, 1545040, 1527810, 1514700, 1530960, 1451920, 1414930, 1438060, 1562990, 1584650, 1618070, 1464580, 1412610, 1412110, 1415460, 1456510, 1475630, 1469310, 1518130, 1522720, 1596600, 1515170, 1623760, 1621530, 1545070, 1598820, 1585800, 1663490, 1650190, 1546900, 1510660, 1552810, 1557000, 1636920, 1532940, 1580220, 1426950, 1386360, 1496720, 1521270, 1461500, 1425850, 1358090, 1395570, 1479740, 1506420, 1603250, 1467500, 1492580, 1565110, 1538700, 1517740, 1524670, 1516880, 1473840, 1416990, 1429370, 1507790, 1489380, 1509160, 1642190, 1624740, 1619430, 1650140, 1474600, 1482260, 1543390, 1585080, 1608210, 1494010, 1614570, 1653870, 1623260, 1533640, 1541350, 1512410, 1475820, 1472690, 1472650, 1394020, 1488360, 1508080, 1561410, 1672620, 1634950, 1534800, 1669750, 1568820, 1524160, 1531990, 1485630, 1503670, 1426340, 1419370, 1397490, 1481970, 1551260, 1466280, 1554710, 1535230, 1542410, 1516240, 1461750, 1536540, 1475700, 1398300, 1404680, 1482500, 1422170, 1576400, 1462920, 1437220, 1395610, 1377360, 1382140, 1463100, 1469000, 1447060, 1491040, 1432360, 1589990, 1559380, 1590630, 1594250, 1665300, 1691610, 1573060, 1522010, 1547640, 1574770, 1554350, 1494690, 1572270, 1555000, 1490060, 1427700, 1475310, 1414090, 1399160, 1487430, 1413880, 1515470, 1486370, 1404920, 1571610, 1567770, 1447520, 1441910, 1498490, 1528440, 1437710, 1443330, 1451580, 1490820, 1503490, 1485830, 1492210, 1528670, 1540060, 1563410, 1628350, 1632290, 1641960, 1687970, 1605010, 1465230, 1493400, 1561370, 1561390, 1467390, 1553050, 1509600, 1534550, 1506670, 1452430, 1555560, 1508820, 1493770, 1494370, 1517280, 1591780, 1566930, 1396160, 1520760, 1457730, 1493660, 1457490, 1488790, 1390500, 1372240, 1433050, 1506930, 1604390, 1469500, 1487740, 1486790, 1407160, 1436630, 1479500, 1488420, 1416050, 1438980, 1440980, 1481200, 1590130, 1560610, 1608740, 1567120, 1541300, 1513980, 1492360, 1513960, 1513050, 1542230, 1518680, 1596940, 1517850, 1560510, 1454120, 1419140, 1450210, 1495100, 1512490, 1536060, 1507230, 1581400, 1601980, 1570510, 1456640, 1476400, 1465160, 1539840, 1494990, 1497970, 1540610, 1568790, 1600410, 1474510, 1403010, 1419980, 1400610, 1416520, 1320380, 1371640, 1314150, 1346870, 1392590, 1346850, 1349170, 1420030, 1418020, 1457070, 1483350, 1566420, 1518530, 1480800, 1611450, 1512890, 1572670, 1541960, 1556710, 1570150, 1586810, 1610530, 1566310, 1488560, 1524020, 1590480, 1635790, 1653670, 1613100, 1458220, 1532440, 1488330, 1450720, 1453060, 1491060, 1511550, 1553460, 1599120, 1534650, 1477340, 1452710, 1474060, 1502800, 1401100, 1427040, 1460560, 1457130, 1409620, 1403890, 1413140, 1354540, 1369300, 1350940, 1325570, 1400080, 1338440, 1422630, 1356210, 1348910, 1381330, 1337760, 1387280, 1480030, 1576950, 1477160, 1595550, 1666720, 1573170, 1495810, 1586950, 1568170), `1979` = c(1634600, 1557920, 1656000, 1522470, 1611870, 1601270, 1715280, 1693590, 1571010, 1571500, 1526250, 1639550, 1624840, 1505770, 1494780, 1507390, 1567740, 1601030, 1485060, 1553880, 1728420, 1699430, 1734440, 1679770, 1658400, 1572720, 1715200, 1659190, 1696080, 1702690, 1765030, 1724590, 1817900, 1755700, 1723980, 1718200, 1684110, 1711760, 1744170, 1722380, 1730320, 1729240, 1629160, 1579550, 1612390, 1652070, 1633390, 1707040, 1663580, 1603450, 1584290, 1689500, 1700710, 1618920, 1722840, 1706980, 1674470, 1660300, 1577950, 1613060, 1598750, 1646040, 1603000, 1708370, 1655700, 1701760, 1647150, 1696540, 1623740, 1657930, 1725240, 1667890, 1636630, 1608170, 1464470, 1558630, 1567670, 1702440, 1647000, 1590050, 1547380, 1632390, 1616760, 1697540, 1674330, 1704110, 1635500, 1716840, 1653150, 1667100, 1767870, 1702780, 1759650, 1751520, 1806360, 1727220, 1708610, 1657300, 1593340, 1498270, 1553390, 1548420, 1531880, 1579920, 1648960, 1630410, 1551100, 1499220, 1475730, 1510850, 1434960, 1618190, 1624000, 1631440, 1554830, 1598830, 1568280, 1506590, 1737910, 1747440, 1682000, 1648160, 1548290, 1565730, 1543290, 1606250, 1585300, 1579240, 1722660, 1698870, 1723710, 1634750, 1681670, 1649150, 1711860, 1816320, 1809260, 1825770, 1729050, 1737320, 1611200, 1643000, 1598980, 1583440, 1614840, 1534030, 1610370, 1537100, 1573200, 1621370, 1626680, 1659850, 1715960, 1750590, 1847870, 1762350, 1654310, 1642980, 1686720, 1790890, 1741510, 1726370, 1660930, 1657050, 1604310, 1761360, 1690970, 1587200, 1632500, 1708650, 1658760, 1584420, 1619760, 1649150, 1672860, 1597240, 1547770, 1622910, 1580470, 1545040, 1652320, 1632630, 1623720, 1648970, 1593830, 1601670, 1557630, 1655280, 1603410, 1568830, 1551440, 1559590, 1631000, 1684680, 1618500, 1552680, 1543000, 1622920, 1642290, 1634920, 1718260, 1687180, 1628450, 1540540, 1518230, 1618380, 1522210, 1605870, 1528940, 1576960, 1595310, 1651900, 1667580, 1673820, 1685070, 1652350, 1729890, 1715440, 1705910, 1679620, 1710090, 1698260, 1619950, 1602730, 1592250, 1551910, 1595530, 1593290, 1591990, 1602000, 1605790, 1663760, 1659590, 1631530, 1709900, 1719650, 1744530, 1775020, 1650500, 1805070, 1680680, 1694720, 1743460, 1699490, 1628440, 1695930, 1610900, 1582740, 1649160, 1650010, 1678820, 1640560, 1604830, 1642430, 1751630, 1757730, 1658770, 1647590, 1665440, 1753130, 1628610, 1731160, 1690130, 1736270, 1641550, 1685660, 1694750, 1665220, 1733110, 1652230, 1584590, 1543160, 1509730, 1626250, 1657800, 1602480, 1656290, 1567730, 1631610, 1730680, 1651000, 1650830, 1670420, 1634770, 1723510, 1695460, 1680910, 1673650, 1585970, 1567210, 1539240, 1623440, 1567640, 1496170, 1669280, 1676270, 1776110, 1702620, 1750550, 1723030, 1644090, 1601990, 1673740, 1683350, 1724640, 1662310, 1571420, 1675880, 1651840, 1743680, 1712890, 1670960, 1568310, 1628350, 1709580, 1635030, 1622100, 1652970, 1624720, 1617040, 1672330, 1613820, 1752480, 1698480, 1737510, 1711520, 1705670, 1682660, 1508590, 1532250, 1652070, 1690840, 1626040, 1637390, 1657030, 1669310, 1561590, 1636200, 1669330, 1721670, 1680620, 1675750, 1779760, 1793500, 1743170, 1735380, 1796760, 1690610, 1688400, 1679680, 1648310, 1603340, 1646450, 1728120, 1744850, 1627610, 1633860, 1687940, 1739380, 1650840, 1637240, 1664640, 1697930, 1695730, 1709120, 1657580, 1681220, 1699010, 1704960, 1761990, 1715500, 1649770, 1622050, 1661860, 1602470, 1580450, 1540240, 1547370, 1524520, 1576480, 1655750, 1682120, 1779600, 1831140, 1746730, 1666150, 1716930, 1700020, 1639750, 1701790, 1699310, 1739080, 1701390, 1750620, 1697830, 1627860, 1652060, 1524770, 1537400, 1693490, 1668130, 1537440, 1518230, 1564900, 1621820, 1618630, 1686180, 1637430, 1592970, 1613450, 1655550, 1685760, 1574070, 1586360, 1598150, 1642110, 1701380, 1697370, 1645410, 1660360, 1714040, 1723910, 1717490, 1785620, 1713900, 1670220, 1651370, 1667100, 1644910, 1604460, 1601170, 1721220, 1847570, 1778910, 1805330, 1745280, 1654820, 1676160, 1685740, 1730740, 1755250, 1636160, 1782510, 1795290, 1659480, 1703740, 1727930, 1680460, 1748680, 1738450, 1731260, 1675550, 1651900, 1585150, 1592460, 1605220, 1537150, 1575910, 1642690, 1665620, 1604160, 1602070, 1537050, 1614700, 1571500, 1535970, 1626340, 1686570, 1622480, 1634090, 1665450, 1611050, 1663200, 1648120, 1610080, 1605730, 1659420, 1730880, 1686660, 1793790, 1766110, 1753400, 1741590, 1627250, 1638140, 1631520, 1643620, 1652440, 1705310, 1655820, 1603880, 1662740, 1642940, 1607300, 1624650, 1627510, 1548970, 1632400, 1613180, 1610420, 1614660, 1524270, 1601430, 1563830, 1511130, 1497570, 1462700, 1529370, 1646280, 1692620, 1667050, 1646980, 1630310, 1544290, 1486640, 1538140, 1546350, 1518590, 1509440, 1514560, 1536670, 1469650, 1449720, 1513710, 1539590, 1565500, 1584110, 1601750, 1530740, 1573900, 1641760, 1647030, 1724700, 1759870, 1654680, 1635020, 1732320, 1693540, 1625920, 1639410, 1610050, 1641680, 1630160, 1673720, 1624950, 1638040, 1705890, 1700920, 1725890, 1669060, 1668640, 1730460, 1741910, 1742120, 1703240, 1672210, 1638520, 1662490, 1674280, 1670320, 1656250, 1673430, 1697990, 1689190, 1638610, 1651100, 1561880, 1540640, 1593920, 1585280, 1664900, 1617410, 1582360, 1700690, 1727960, 1778690, 1682810, 1647400, 1687220, 1721890, 1704490, 1691570, 1660070, 1582940, 1567420, 1557390, 1594120, 1637150, 1683480, 1678760, 1577590, 1627510, 1705260, 1761740, 1755360, 1707690, 1644860, 1695230, 1663580, 1611430, 1633140, 1673930, 1646000, 1583160, 1636140, 1711410, 1771600, 1808700, 1694650, 1720630, 1614210, 1671200, 1665540, 1704050, 1740710, 1662930, 1598080, 1538450, 1609600, 1708800, 1620490, 1750140, 1623830, 1586320, 1708280, 1598340, 1646710, 1610490, 1556810, 1643110, 1725450, 1823020, 1788500, 1745830, 1799880, 1654470, 1629970, 1574750, 1487140, 1570010, 1528960, 1619810, 1621330, 1649730, 1594560, 1609820, 1555640, 1641720, 1651920, 1702240, 1654680, 1670910, 1645510, 1548800, 1652150, 1608330, 1512170, 1576290, 1599550, 1567420, 1680070, 1552200, 1663940, 1667320, 1711690, 1709530, 1624020, 1674850, 1712910, 1664780, 1642440, 1679290, 1723340, 1719530, 1731720, 1689660, 1630310, 1649220, 1640990, 1694390, 1662550, 1639300, 1667270, 1667050, 1705650, 1646420, 1575340, 1590850, 1617410, 1616160, 1645820, 1626680, 1565840, 1529010, 1588410, 1636050, 1639770, 1715850, 1652220, 1579290, 1623360, 1631650, 1643680, 1639680, 1611580, 1658310, 1671740, 1782910, 1697210, 1810010, 1779390, 1732060, 1775260, 1772900, 1843330, 1764590, 1665020, 1585560, 1674670, 1666820, 1731300, 1625790, 1731790, 1644590, 1567680, 1688280, 1715310, 1670970, 1583780, 1550900, 1572610, 1647690, 1652570, 1716610, 1579640, 1610440, 1649110, 1616650, 1619810, 1600710, 1607890, 1606750, 1559880, 1574450, 1678040, 1640100, 1677830, 1779210, 1815830, 1778550, 1782860, 1670620, 1638020, 1662180, 1718450, 1735170, 1650400, 1702570, 1754680, 1774010, 1773880, 1739930, 1676650, 1673120, 1698430, 1722150, 1622590, 1627140, 1663140, 1680090, 1728270, 1752120, 1685020, 1788460, 1693690, 1651250, 1642860, 1575610, 1581870, 1529930, 1550240, 1585180, 1619620, 1632250, 1574840, 1662550, 1653870, 1666670, 1617900, 1540840, 1649570, 1660860, 1644050, 1676100, 1655190, 1595170, 1680800, 1594050, 1610660, 1568270, 1567910, 1558740, 1676430, 1667310, 1608310, 1631840, 1612700, 1732840, 1725770, 1673890, 1707310, 1782250, 1792330, 1677100, 1605910, 1649330, 1682280, 1655220, 1556550, 1662410, 1619790, 1583290, 1560060, 1575120, 1580430, 1542180, 1623220, 1537860, 1602470, 1595950, 1545350, 1661610, 1666660, 1620610, 1570520, 1616870, 1620760, 1549830, 1576960, 1576050, 1615190, 1635520, 1595150, 1623380, 1619200, 1629050, 1640670, 1665210, 1714530, 1719780, 1781370, 1715400, 1628460, 1673570, 1706860, 1719140, 1631890, 1711250, 1720510, 1688940, 1664410, 1539460, 1642670, 1602220, 1625170, 1650410, 1639200, 1698920, 1654130, 1510740, 1649160, 1577850, 1590220, 1547930, 1615080, 1543840, 1545080, 1586050, 1641950, 1671800, 1607440, 1641310, 1629250, 1556060, 1606390, 1673020, 1638370, 1573850, 1553550, 1528900, 1572650, 1627000, 1646170, 1696000, 1669500, 1649020, 1627020, 1632240, 1633620, 1629080, 1613660, 1642980, 1674690, 1606030, 1649390, 1599720, 1578850, 1595120, 1631550, 1623200, 1641170, 1592380, 1655460, 1669140, 1657570, 1599110, 1603670, 1589810, 1672540, 1610110, 1652720, 1705660, 1686560, 1699370, 1641360, 1592790, 1598570, 1564200, 1525380, 1461580, 1551550, 1505060, 1535580, 1575380, 1527100, 1539550, 1581540, 1542560, 1582870, 1592610, 1713750, 1699820, 1607200, 1705580, 1641270, 1705220, 1655510, 1681890, 1645920, 1635670, 1694560, 1664450, 1636670, 1664730, 1757480, 1808020, 1750330, 1727230, 1543900, 1552590, 1555650, 1486740, 1530510, 1562600, 1574700, 1599680, 1654510, 1626130, 1611630, 1582090, 1597540, 1635720, 1565630, 1593420, 1630690, 1592700, 1535760, 1593550, 1612640, 1508230, 1516050, 1498200, 1470610, 1529980, 1500930, 1557230, 1507160, 1449930, 1443360, 1420230, 1483970, 1572150, 1683010, 1638110, 1719680, 1771860, 1675720, 1637160, 1726650, 1701180), `1980` = c(1749950, 1709590, 1743860, 1651860, 1710070, 1699140, 1793950, 1811770, 1681440, 1674240, 1707960, 1728500, 1741430, 1714840, 1707940, 1812060, 1693050, 1753320, 1665330, 1771710, 1882680, 1848860, 1786930, 1791550, 1803310, 1698350, 1798880, 1697780, 1743840, 1720660, 1765600, 1737910, 1823450, 1777210, 1810050, 1819070, 1767360, 1811100, 1828280, 1808570, 1867240, 1869050, 1779050, 1686680, 1663040, 1685490, 1684000, 1728600, 1712890, 1675670, 1725540, 1776200, 1815030, 1767340, 1840230, 1748150, 1718360, 1777460, 1718570, 1741260, 1691230, 1773700, 1749760, 1825590, 1770120, 1777560, 1791930, 1752150, 1705930, 1723670, 1758130, 1700850, 1739270, 1771970, 1647510, 1700340, 1727250, 1779500, 1740490, 1735110, 1693400, 1754060, 1697700, 1775360, 1702330, 1718100, 1740600, 1848370, 1838950, 1836950, 1902790, 1861930, 1898180, 1858350, 1870350, 1856690, 1812350, 1816670, 1732410, 1657440, 1660000, 1674770, 1667190, 1698370, 1756600, 1743620, 1698590, 1730640, 1706860, 1675740, 1606610, 1739390, 1724340, 1733360, 1691990, 1755910, 1663440, 1605430, 1835960, 1840440, 1735020, 1739620, 1660890, 1683850, 1667690, 1714110, 1730970, 1757130, 1846370, 1830440, 1890340, 1771630, 1894820, 1877250, 1943200, 1894150, 1895250, 1897570, 1794940, 1805140, 1701630, 1736700, 1715020, 1742720, 1776240, 1747050, 1792180, 1673550, 1707360, 1710380, 1743020, 1754780, 1773990, 1859300, 1942990, 1897400, 1783280, 1795440, 1798360, 1854320, 1794980, 1792460, 1806210, 1837120, 1784400, 1838930, 1746540, 1698350, 1747670, 1818510, 1747550, 1696790, 1772360, 1711470, 1748130, 1709830, 1640080, 1731520, 1714320, 1718140, 1831310, 1798950, 1757650, 1736660, 1674260, 1698580, 1707130, 1760570, 1736410, 1745360, 1714570, 1711350, 1751120, 1728380, 1717750, 1673060, 1681170, 1775200, 1781290, 1808460, 1784720, 1774220, 1767790, 1693750, 1675960, 1746390, 1645420, 1700180, 1681510, 1715070, 1706000, 1720760, 1707960, 1716440, 1692360, 1674170, 1741260, 1738200, 1769910, 1743290, 1793240, 1796870, 1713160, 1741250, 1755600, 1694120, 1739090, 1720810, 1751310, 1743870, 1752630, 1761740, 1821350, 1787760, 1839890, 1854110, 1901320, 1874680, 1800500, 1921910, 1764830, 1796650, 1852790, 1811800, 1755920, 1827630, 1719680, 1735260, 1751100, 1751060, 1751540, 1678770, 1706080, 1746300, 1803050, 1804440, 1747890, 1797160, 1803660, 1824260, 1747260, 1783920, 1772110, 1867820, 1772700, 1788830, 1781240, 1778230, 1867670, 1805060, 1722040, 1738430, 1669530, 1700770, 1781150, 1834430, 1793240, 1720540, 1765440, 1813570, 1771260, 1790360, 1833590, 1768990, 1782530, 1784390, 1816380, 1792730, 1715310, 1685490, 1702950, 1794420, 1761410, 1737330, 1862790, 1811690, 1910510, 1791450, 1849870, 1783970, 1739670, 1705290, 1783980, 1795720, 1847460, 1785140, 1694350, 1717980, 1787210, 1828470, 1835570, 1797030, 1680080, 1703780, 1792690, 1725470, 1734630, 1796850, 1786020, 1764190, 1779330, 1689000, 1856690, 1777070, 1800660, 1796620, 1750270, 1742660, 1576200, 1586410, 1701650, 1746470, 1696240, 1744760, 1799240, 1828280, 1766550, 1782210, 1760750, 1832740, 1789360, 1782080, 1851900, 1861570, 1752250, 1766630, 1831470, 1764560, 1772910, 1776740, 1740360, 1784830, 1812260, 1883960, 1906930, 1850490, 1802540, 1778800, 1831590, 1783030, 1775510, 1796960, 1830710, 1852090, 1884310, 1794750, 1822200, 1836920, 1850460, 1883250, 1816290, 1764240, 1754310, 1767970, 1721230, 1718930, 1726800, 1714860, 1706620, 1710470, 1707410, 1709120, 1748980, 1835500, 1821120, 1744280, 1770590, 1796390, 1759090, 1848300, 1833830, 1861480, 1817130, 1790720, 1760420, 1706800, 1733370, 1634790, 1640770, 1760230, 1758110, 1664170, 1663640, 1674520, 1703520, 1691070, 1776410, 1715150, 1692630, 1743840, 1826190, 1885280, 1801410, 1781120, 1782220, 1844660, 1834160, 1788600, 1793180, 1739640, 1798830, 1827820, 1855490, 1879700, 1802530, 1815850, 1809550, 1790070, 1755660, 1730980, 1741450, 1849210, 1969730, 1953060, 1978480, 1889310, 1827640, 1773740, 1810700, 1835260, 1856750, 1753690, 1846140, 1857610, 1760870, 1805000, 1834110, 1810020, 1838710, 1787570, 1785250, 1792830, 1731840, 1696530, 1709670, 1754190, 1704960, 1711750, 1799300, 1775750, 1754330, 1713960, 1710660, 1785470, 1732990, 1724590, 1760650, 1790430, 1762480, 1778910, 1752620, 1666140, 1689130, 1654780, 1636160, 1648980, 1734660, 1778990, 1715340, 1814070, 1809880, 1783110, 1775370, 1727730, 1735150, 1700390, 1747190, 1767070, 1811750, 1762410, 1713580, 1776430, 1742550, 1715350, 1726590, 1717180, 1712890, 1799000, 1739100, 1756560, 1775360, 1688060, 1780000, 1751130, 1669860, 1653630, 1661520, 1677060, 1721390, 1756510, 1783510, 1780820, 1753200, 1666110, 1685570, 1697670, 1702720, 1729600, 1755810, 1703210, 1709730, 1628620, 1637050, 1706690, 1717220, 1722610, 1786610, 1747820, 1668190, 1704780, 1709210, 1769790, 1870590, 1886280, 1777550, 1797890, 1860490, 1830220, 1768130, 1746740, 1770730, 1739280, 1741270, 1764830, 1744640, 1732330, 1767780, 1754350, 1778720, 1735360, 1706320, 1764890, 1787450, 1831720, 1829000, 1804990, 1758090, 1804430, 1774970, 1813850, 1828820, 1782250, 1800530, 1824200, 1789990, 1811830, 1737350, 1707260, 1709180, 1716510, 1779960, 1760280, 1757330, 1817030, 1818440, 1912870, 1826240, 1715630, 1773240, 1799680, 1793150, 1788660, 1742860, 1685630, 1666530, 1670630, 1716980, 1746030, 1766290, 1784110, 1712270, 1785890, 1842770, 1837260, 1840100, 1768780, 1733360, 1817110, 1805730, 1754740, 1762440, 1788630, 1779340, 1679240, 1737710, 1818650, 1852940, 1862790, 1766700, 1812760, 1722620, 1783460, 1798820, 1812750, 1892280, 1814000, 1775370, 1782020, 1795220, 1825910, 1766680, 1831680, 1760270, 1712080, 1800420, 1684760, 1772170, 1755140, 1703140, 1793730, 1805910, 1866110, 1875610, 1867670, 1922370, 1796220, 1792540, 1698580, 1661200, 1656260, 1680120, 1735440, 1718450, 1782670, 1746340, 1746770, 1700170, 1728770, 1773280, 1837710, 1802260, 1828630, 1811740, 1710320, 1764940, 1702750, 1567490, 1670100, 1707180, 1728620, 1804940, 1649320, 1708240, 1680270, 1781410, 1782280, 1734800, 1726650, 1752880, 1704790, 1728960, 1770410, 1811440, 1868190, 1850410, 1821490, 1825810, 1785840, 1767250, 1807960, 1768460, 1757080, 1774580, 1744030, 1769000, 1771220, 1714940, 1694600, 1695760, 1717800, 1751550, 1755520, 1702570, 1679030, 1762520, 1771950, 1756290, 1739930, 1738750, 1678350, 1715440, 1761650, 1803570, 1840940, 1808910, 1861490, 1830890, 1911010, 1845140, 1876440, 1810080, 1797150, 1846740, 1861870, 1898500, 1819790, 1784170, 1742110, 1790360, 1774390, 1828080, 1763890, 1820420, 1771250, 1703830, 1824750, 1815440, 1800670, 1779520, 1756780, 1763660, 1835260, 1772540, 1809630, 1699880, 1756550, 1785760, 1737380, 1706530, 1691480, 1666160, 1673170, 1638900, 1660170, 1749510, 1714730, 1792270, 1832060, 1856760, 1869550, 1864650, 1798430, 1770000, 1742150, 1779310, 1744430, 1702000, 1732280, 1771300, 1809170, 1826730, 1810370, 1740890, 1739510, 1795890, 1804440, 1720950, 1714620, 1782870, 1804040, 1824830, 1862790, 1753940, 1846750, 1731840, 1742240, 1804830, 1760940, 1784340, 1757960, 1734760, 1714460, 1705020, 1680470, 1665690, 1733510, 1742320, 1760850, 1701690, 1613900, 1755440, 1785410, 1791190, 1811590, 1751200, 1752180, 1827830, 1754260, 1725230, 1690070, 1678970, 1662160, 1775900, 1766020, 1680540, 1743110, 1771660, 1800800, 1799470, 1775750, 1791780, 1825620, 1845260, 1795140, 1732010, 1763280, 1771420, 1762230, 1699600, 1779400, 1768440, 1733010, 1678450, 1709390, 1744830, 1704720, 1789060, 1722980, 1763430, 1754310, 1704130, 1796100, 1836580, 1818150, 1764630, 1771780, 1771850, 1710280, 1765800, 1757940, 1781050, 1766120, 1700400, 1743780, 1711460, 1742690, 1780970, 1801380, 1835720, 1833690, 1861230, 1796750, 1724200, 1793940, 1828470, 1794760, 1730830, 1797460, 1790210, 1786880, 1763050, 1740390, 1810030, 1753650, 1764840, 1772790, 1789870, 1836450, 1743740, 1659400, 1810910, 1762500, 1770050, 1706880, 1741400, 1706000, 1721060, 1753680, 1749080, 1702860, 1693750, 1695580, 1713060, 1708670, 1741420, 1779150, 1747420, 1708100, 1694670, 1714460, 1739500, 1754310, 1746220, 1753710, 1730580, 1709480, 1681650, 1684000, 1691000, 1729680, 1687600, 1722200, 1754270, 1739070, 1783940, 1724390, 1703260, 1699350, 1752740, 1711750, 1744760, 1718210, 1777250, 1752100, 1690690, 1631710, 1658450, 1653280, 1705520, 1638700, 1692720, 1741780, 1717900, 1699320, 1660770, 1625670, 1658380, 1643120, 1643100, 1589760, 1644200, 1630050, 1652030, 1720850, 1700740, 1697250, 1710870, 1672750, 1737220, 1770970, 1829330, 1802820, 1753110, 1790550, 1768070, 1861710, 1865110, 1853530, 1795370, 1735430, 1826880, 1816380, 1769350, 1752940, 1856600, 1916270, 1831380, 1829880, 1701510, 1717430, 1749190, 1724940, 1719690, 1669530, 1651670, 1693850, 1796050, 1726220, 1710920, 1748020, 1808420, 1838050, 1779970, 1759460, 1799070, 1816670, 1714300, 1741190, 1733160, 1696680, 1749240, 1721060, 1702410, 1687630, 1677800, 1758620, 1758890, 1719000, 1688710, 1675920, 1689820, 1713240, 1826800, 1776690, 1869970, 1882260, 1783540, 1773020, 1785660, 1784450), `1981` = c(1410130, 1433770, 1440220, 1382630, 1375740, 1356490, 1447910, 1464760, 1379550, 1415030, 1420670, 1480170, 1413050, 1406810, 1420680, 1513720, 1348630, 1388960, 1346440, 1436270, 1541050, 1508060, 1473070, 1478260, 1432000, 1379270, 1471340, 1413160, 1373110, 1353510, 1362020, 1340500, 1405950, 1406850, 1408610, 1415260, 1421960, 1455020, 1489480, 1481010, 1554280, 1543120, 1481070, 1367450, 1373780, 1409170, 1384070, 1413030, 1377410, 1370330, 1408380, 1432190, 1430750, 1437800, 1490400, 1383370, 1397310, 1462410, 1390170, 1378140, 1341890, 1425860, 1360710, 1425430, 1405450, 1415470, 1445120, 1442920, 1380460, 1382910, 1400710, 1332250, 1386470, 1426670, 1321330, 1383300, 1390170, 1402710, 1392530, 1395980, 1320310, 1387580, 1390190, 1447160, 1367640, 1377030, 1432400, 1478750, 1521960, 1498650, 1520530, 1521330, 1530690, 1481900, 1494190, 1478590, 1472320, 1468400, 1414830, 1320300, 1347900, 1381070, 1358530, 1360050, 1387520, 1411170, 1358400, 1395570, 1402720, 1373610, 1337880, 1400470, 1399030, 1398990, 1365680, 1396680, 1299040, 1307670, 1450920, 1440630, 1345020, 1353270, 1277000, 1300030, 1305250, 1336470, 1332300, 1362610, 1453810, 1447930, 1509110, 1438110, 1515550, 1477730, 1539980, 1535970, 1511270, 1509460, 1447340, 1466740, 1375740, 1401220, 1424420, 1440850, 1511010, 1489120, 1497140, 1389990, 1413160, 1448610, 1463180, 1451960, 1451410, 1490530, 1543100, 1524790, 1403170, 1428720, 1430700, 1471640, 1434190, 1406620, 1465670, 1492080, 1462080, 1461470, 1391030, 1380090, 1407860, 1435940, 1395250, 1351410, 1455620, 1417350, 1453460, 1440090, 1398430, 1454370, 1427050, 1416970, 1497440, 1479840, 1425340, 1407570, 1328640, 1330860, 1383550, 1446650, 1406660, 1426500, 1420590, 1408750, 1415350, 1373350, 1388240, 1337020, 1319570, 1404020, 1400930, 1408220, 1401100, 1438550, 1473980, 1342540, 1311610, 1428730, 1394180, 1407520, 1395820, 1417540, 1387930, 1402510, 1371220, 1402820, 1440540, 1397270, 1413240, 1410090, 1425550, 1401390, 1427820, 1455240, 1378780, 1414270, 1416320, 1374000, 1414800, 1398510, 1416630, 1429030, 1461590, 1421060, 1461690, 1450540, 1514520, 1520660, 1522110, 1484620, 1475520, 1551850, 1419050, 1458760, 1498550, 1445870, 1399280, 1476420, 1392470, 1411430, 1402690, 1414550, 1401410, 1361350, 1391480, 1392880, 1456380, 1421670, 1410930, 1456880, 1431750, 1458250, 1405180, 1414970, 1442730, 1470510, 1404100, 1439690, 1451710, 1477770, 1499320, 1492700, 1473660, 1394910, 1330300, 1330890, 1407820, 1456640, 1414330, 1366610, 1369460, 1404360, 1362920, 1364230, 1408950, 1379460, 1372110, 1357920, 1390700, 1384800, 1335790, 1329520, 1354660, 1405020, 1402490, 1357180, 1478520, 1438530, 1512640, 1414800, 1465900, 1414220, 1366540, 1328660, 1407590, 1408470, 1451670, 1396650, 1347570, 1330110, 1396650, 1442400, 1456430, 1442980, 1376230, 1396610, 1435790, 1376090, 1398050, 1458410, 1450140, 1431810, 1420710, 1355600, 1499570, 1419880, 1419740, 1450000, 1432780, 1429200, 1264680, 1284590, 1367470, 1441060, 1389920, 1414520, 1441320, 1463760, 1440850, 1449270, 1431260, 1469640, 1428550, 1426580, 1469500, 1468660, 1399470, 1413980, 1438760, 1393060, 1385490, 1390000, 1326840, 1383110, 1421770, 1489000, 1536800, 1473710, 1418610, 1414880, 1441130, 1416780, 1401570, 1419630, 1465100, 1501410, 1519550, 1422450, 1464110, 1465690, 1479310, 1509630, 1456130, 1440990, 1392190, 1410290, 1370620, 1364460, 1384000, 1395780, 1397250, 1398980, 1347280, 1364580, 1430520, 1462490, 1468620, 1425680, 1399650, 1403270, 1374850, 1481720, 1459740, 1489340, 1467740, 1422070, 1400160, 1355090, 1390060, 1382370, 1350840, 1456740, 1419750, 1323480, 1320210, 1370150, 1410840, 1397280, 1434720, 1414680, 1414710, 1463290, 1512930, 1560950, 1514860, 1499940, 1489370, 1504450, 1473350, 1395130, 1424910, 1348370, 1381320, 1431650, 1456990, 1468540, 1426160, 1440860, 1440700, 1424710, 1404940, 1353650, 1404240, 1501010, 1551960, 1544940, 1573340, 1492230, 1501990, 1409070, 1482250, 1498190, 1477310, 1409870, 1522530, 1560350, 1480550, 1480140, 1489230, 1462710, 1451090, 1427610, 1435940, 1420430, 1385710, 1365480, 1382030, 1403270, 1340730, 1403580, 1456930, 1432620, 1420520, 1461270, 1419970, 1432740, 1415420, 1381350, 1446850, 1475760, 1456880, 1445660, 1424380, 1371710, 1351380, 1306050, 1314590, 1307720, 1387640, 1409110, 1326260, 1423430, 1432850, 1380290, 1368320, 1357340, 1373190, 1361960, 1398290, 1417190, 1469770, 1450800, 1429410, 1448050, 1429860, 1394270, 1379300, 1356360, 1324940, 1403620, 1380360, 1397600, 1424320, 1363660, 1439960, 1432660, 1370040, 1352170, 1359900, 1342420, 1391360, 1389520, 1414560, 1430270, 1396160, 1320530, 1348750, 1352630, 1367660, 1403010, 1424620, 1406060, 1428950, 1368570, 1367440, 1399860, 1400480, 1399750, 1457990, 1425260, 1378700, 1397260, 1424960, 1411990, 1478310, 1490180, 1404870, 1424750, 1447550, 1446250, 1393910, 1408910, 1459000, 1427780, 1433700, 1406790, 1398910, 1387270, 1420650, 1397160, 1391790, 1373880, 1337310, 1382320, 1377930, 1414560, 1435510, 1432680, 1424610, 1442940, 1404600, 1460160, 1530680, 1443320, 1448000, 1444310, 1433170, 1435550, 1386510, 1368630, 1389310, 1409230, 1456150, 1432750, 1423630, 1470180, 1466380, 1544160, 1453090, 1342150, 1397750, 1401310, 1405890, 1393330, 1378280, 1332280, 1319000, 1316010, 1375910, 1391510, 1412870, 1439460, 1421230, 1441670, 1459300, 1452210, 1449980, 1407930, 1354290, 1413910, 1413930, 1382400, 1380910, 1409590, 1414570, 1333850, 1405310, 1474390, 1510170, 1463890, 1412750, 1442590, 1381280, 1425310, 1436100, 1437490, 1505950, 1458140, 1442540, 1445950, 1468270, 1469320, 1424290, 1482850, 1427200, 1429550, 1479570, 1376080, 1443770, 1402220, 1362570, 1445390, 1422830, 1483930, 1468580, 1483720, 1551170, 1441750, 1494880, 1451540, 1349260, 1371770, 1412370, 1403570, 1381900, 1412230, 1385550, 1401970, 1362660, 1367790, 1444510, 1470140, 1438810, 1476490, 1467630, 1401220, 1442120, 1412510, 1289890, 1379760, 1410190, 1466610, 1475620, 1357350, 1393510, 1334920, 1434700, 1442210, 1454130, 1417480, 1417590, 1399370, 1410120, 1429600, 1459540, 1495360, 1481170, 1465790, 1450530, 1408120, 1377120, 1462230, 1426130, 1393250, 1380940, 1382610, 1435870, 1433050, 1382290, 1372200, 1369600, 1369010, 1378380, 1389530, 1398200, 1353980, 1406290, 1433820, 1401100, 1371290, 1385010, 1391430, 1411660, 1392850, 1419090, 1512440, 1433130, 1493640, 1475010, 1548690, 1503820, 1518990, 1493640, 1459990, 1482490, 1491510, 1529610, 1466950, 1432470, 1403580, 1430880, 1412330, 1442350, 1413940, 1465980, 1445930, 1348140, 1475980, 1453230, 1462040, 1424250, 1423900, 1447290, 1495360, 1414230, 1441990, 1357980, 1430380, 1435890, 1406680, 1381900, 1389900, 1397920, 1373760, 1340660, 1353790, 1400390, 1411800, 1451490, 1434680, 1473300, 1464120, 1457760, 1412200, 1378080, 1359750, 1411530, 1347550, 1304280, 1337180, 1380250, 1408210, 1427580, 1436820, 1404250, 1376600, 1386120, 1434770, 1377100, 1391270, 1447940, 1434420, 1488010, 1551210, 1426820, 1480860, 1393170, 1363680, 1463550, 1451650, 1482120, 1462810, 1439330, 1384020, 1358370, 1343910, 1342030, 1391480, 1371980, 1397950, 1377470, 1295730, 1440880, 1477200, 1452050, 1423860, 1404970, 1394150, 1427130, 1376960, 1369420, 1337090, 1356930, 1294670, 1368870, 1356370, 1301510, 1358640, 1417030, 1406580, 1443460, 1441410, 1449480, 1481630, 1477920, 1456860, 1410760, 1421900, 1420270, 1434450, 1392610, 1485680, 1434090, 1394500, 1373520, 1391210, 1441060, 1402150, 1490400, 1467090, 1450540, 1383150, 1354210, 1402990, 1444870, 1412740, 1366040, 1392590, 1369820, 1332260, 1373660, 1382230, 1400900, 1395470, 1358430, 1423770, 1410660, 1416820, 1416380, 1417100, 1432600, 1437170, 1432540, 1391540, 1331820, 1401800, 1423840, 1393530, 1349840, 1414620, 1426460, 1431720, 1442210, 1445880, 1466700, 1395750, 1415060, 1430260, 1421020, 1467220, 1416610, 1359690, 1451490, 1409850, 1415290, 1374770, 1419030, 1410340, 1393440, 1382450, 1380910, 1341700, 1350680, 1359390, 1341970, 1329750, 1352590, 1410800, 1384960, 1354190, 1350690, 1335770, 1325070, 1343880, 1340860, 1345120, 1326290, 1329360, 1292820, 1318230, 1359330, 1387430, 1360160, 1369800, 1389360, 1384570, 1444730, 1394130, 1373220, 1361020, 1395370, 1353130, 1417450, 1412830, 1439030, 1410480, 1350800, 1306660, 1329090, 1305520, 1359680, 1317020, 1344840, 1402420, 1377440, 1357520, 1352390, 1319780, 1318650, 1309870, 1356870, 1304320, 1320030, 1315440, 1348970, 1397100, 1389980, 1372470, 1435570, 1384180, 1445100, 1480220, 1501460, 1500160, 1467660, 1458270, 1454160, 1553800, 1531260, 1515780, 1455190, 1381650, 1452670, 1428570, 1399940, 1371250, 1438160, 1472050, 1421630, 1405120, 1294090, 1316720, 1355050, 1342840, 1369800, 1346660, 1337010, 1385500, 1425310, 1401600, 1367430, 1408460, 1437700, 1465950, 1412190, 1389990, 1404880, 1453180, 1427910, 1441150, 1463530, 1420710, 1477080, 1439900, 1437610, 1400240, 1363840, 1429340, 1453840, 1444370, 1391020, 1354620, 1358700, 1362310, 1430900, 1390490, 1475570, 1478100, 1376430, 1406740, 1435100, 1404820), `1982` = c(1130650, 1142000, 1151980, 1088910, 1031340, 1037080, 1143560, 1160110, 1126230, 1157610, 1126570, 1167160, 1073750, 1081560, 1099410, 1213930, 1082150, 1118000, 1058800, 1144510, 1252610, 1221340, 1243620, 1257780, 1180360, 1135400, 1198980, 1148740, 1118800, 1112200, 1095670, 1074070, 1104090, 1126440, 1120640, 1131040, 1163330, 1207060, 1226770, 1216620, 1268680, 1230990, 1171440, 1104120, 1099140, 1130540, 1106130, 1111000, 1062680, 1090340, 1123840, 1139170, 1120450, 1143970, 1171140, 1069800, 1108930, 1184210, 1130260, 1109880, 1098400, 1190140, 1131620, 1117210, 1130750, 1150330, 1157670, 1155240, 1093530, 1092770, 1140590, 1083200, 1108260, 1151990, 1020480, 1113580, 1116080, 1129480, 1112420, 1135130, 1056690, 1153660, 1106920, 1152830, 1110590, 1118860, 1200470, 1224120, 1237960, 1207210, 1219370, 1235640, 1231660, 1187370, 1197620, 1223890, 1206220, 1200230, 1143520, 1063240, 1106600, 1161080, 1110600, 1127720, 1132440, 1131030, 1082190, 1103270, 1110920, 1086360, 1041240, 1098040, 1101300, 1096230, 1069510, 1104490, 1014860, 1045200, 1159620, 1164570, 1068920, 1057600, 999039, 1019740, 1048690, 1073750, 1086180, 1111040, 1198750, 1172680, 1210010, 1160590, 1229890, 1209600, 1242580, 1211970, 1192730, 1199790, 1133610, 1157750, 1076560, 1124290, 1153090, 1182770, 1239380, 1206480, 1219720, 1095370, 1125100, 1169930, 1196960, 1187180, 1149800, 1206360, 1224530, 1225570, 1112330, 1150910, 1166380, 1167510, 1098600, 1080210, 1142700, 1159310, 1156960, 1162420, 1118420, 1133540, 1149730, 1149050, 1128900, 1080100, 1163480, 1130510, 1168460, 1146160, 1118180, 1151140, 1132780, 1142590, 1213470, 1201610, 1163750, 1141840, 1087460, 1077270, 1075780, 1104360, 1109270, 1102640, 1107520, 1093220, 1107950, 1090560, 1099520, 1060580, 1040580, 1114460, 1107970, 1090630, 1083410, 1122040, 1175060, 1107210, 1067370, 1139820, 1089140, 1086370, 1093150, 1114220, 1078360, 1092260, 1077230, 1143340, 1181720, 1117940, 1129250, 1120580, 1091060, 1104860, 1113290, 1155970, 1113200, 1147910, 1152240, 1104430, 1146070, 1131140, 1098780, 1110920, 1130540, 1087400, 1133890, 1108920, 1153520, 1169230, 1183430, 1145990, 1145170, 1227040, 1117730, 1176980, 1211760, 1151390, 1138360, 1217200, 1106160, 1148100, 1127280, 1155620, 1139830, 1146010, 1149640, 1157470, 1201520, 1160320, 1185340, 1216670, 1157670, 1170890, 1112940, 1110080, 1162490, 1216990, 1153450, 1188810, 1181830, 1182510, 1190690, 1200120, 1192000, 1119670, 1072530, 1022260, 1105100, 1159180, 1126870, 1103960, 1072570, 1107970, 1060390, 1032000, 1124820, 1116970, 1107610, 1085150, 1104410, 1121660, 1066650, 1060840, 1067990, 1094870, 1096560, 1068630, 1164780, 1148240, 1209320, 1118270, 1153960, 1143390, 1098720, 1057760, 1141190, 1166630, 1177950, 1122530, 1056380, 1076090, 1121810, 1166210, 1179440, 1181750, 1115920, 1138080, 1152560, 1060000, 1073370, 1136340, 1145490, 1142950, 1124520, 1056930, 1194060, 1129220, 1170520, 1177050, 1200340, 1205390, 1064380, 1052600, 1109710, 1165600, 1121530, 1120320, 1150520, 1174550, 1163270, 1181110, 1129890, 1175530, 1161070, 1178460, 1183950, 1166630, 1129890, 1151790, 1170870, 1109720, 1123270, 1148840, 1102030, 1115610, 1188160, 1237580, 1260060, 1191310, 1140880, 1135080, 1158990, 1142320, 1118340, 1170090, 1209470, 1258650, 1265650, 1193450, 1238200, 1216220, 1217600, 1249210, 1212850, 1206820, 1145410, 1156210, 1140650, 1133240, 1146410, 1134920, 1119130, 1135580, 1068580, 1075630, 1155240, 1142620, 1135910, 1092520, 1086930, 1076920, 1054640, 1153920, 1118230, 1167310, 1175050, 1136010, 1109340, 1075260, 1126550, 1093390, 1073500, 1146040, 1141680, 1041780, 1060550, 1132470, 1158720, 1126770, 1147870, 1122620, 1147440, 1189290, 1246980, 1292160, 1254660, 1231890, 1195740, 1223920, 1198060, 1150680, 1185980, 1114640, 1148380, 1178050, 1180670, 1165730, 1134790, 1143640, 1170720, 1169530, 1149560, 1100820, 1105790, 1156830, 1205600, 1241340, 1258000, 1162090, 1199430, 1118860, 1175710, 1181360, 1148220, 1115070, 1174420, 1227510, 1151410, 1134920, 1168160, 1164080, 1141360, 1113980, 1127650, 1113860, 1086530, 1093150, 1093620, 1107670, 1046360, 1097650, 1153420, 1122660, 1108880, 1139100, 1123080, 1140470, 1116710, 1088820, 1181890, 1182440, 1165310, 1148720, 1137710, 1067540, 1109540, 1091760, 1068270, 1059670, 1143230, 1162110, 1050700, 1147020, 1147250, 1107290, 1103260, 1121010, 1080520, 1058750, 1075930, 1117440, 1165260, 1166130, 1147530, 1165280, 1157040, 1101400, 1120210, 1079630, 1052940, 1120120, 1087280, 1110640, 1165130, 1101800, 1181680, 1145870, 1087310, 1080280, 1126940, 1110290, 1130150, 1155970, 1142170, 1152690, 1119830, 1060700, 1112680, 1104410, 1116930, 1158990, 1152160, 1134410, 1165420, 1120270, 1129420, 1142080, 1165440, 1155820, 1178720, 1137830, 1116240, 1149060, 1133500, 1149430, 1199900, 1189390, 1157810, 1169120, 1181610, 1155340, 1128860, 1151270, 1172740, 1141360, 1145250, 1133080, 1135430, 1131100, 1141790, 1120000, 1119200, 1117020, 1096320, 1121310, 1103020, 1123990, 1157610, 1161730, 1153360, 1173930, 1115610, 1157870, 1225950, 1150800, 1161140, 1178110, 1176460, 1159680, 1125730, 1117260, 1126360, 1150120, 1180900, 1118350, 1112920, 1165400, 1137270, 1228470, 1214120, 1149910, 1142600, 1122280, 1094260, 1078020, 1095960, 1073530, 1039130, 1034050, 1098040, 1093820, 1121900, 1141930, 1116620, 1123440, 1153100, 1173710, 1175010, 1136100, 1077240, 1157130, 1132280, 1113560, 1141660, 1192980, 1176940, 1095850, 1157320, 1174670, 1173550, 1165990, 1127680, 1189960, 1148310, 1146100, 1161820, 1156440, 1215560, 1181700, 1165650, 1183110, 1195370, 1171000, 1120590, 1182320, 1145160, 1161090, 1178750, 1121740, 1173140, 1123570, 1107820, 1194030, 1206060, 1205740, 1155960, 1176910, 1241710, 1127620, 1160960, 1140010, 1045920, 1059710, 1116330, 1122530, 1087820, 1124310, 1084830, 1102060, 1093490, 1060510, 1134280, 1133130, 1141150, 1147270, 1125650, 1094810, 1108440, 1088240, 1002340, 1077610, 1118030, 1178470, 1173480, 1069150, 1101310, 1051000, 1129580, 1131130, 1125990, 1088980, 1122060, 1104600, 1106190, 1139870, 1165840, 1184750, 1192570, 1206280, 1180760, 1106740, 1077540, 1151950, 1106170, 1061920, 1074790, 1080180, 1139890, 1137170, 1101990, 1101390, 1121140, 1107960, 1115690, 1112990, 1115700, 1119280, 1102000, 1135670, 1093810, 1060880, 1088600, 1101380, 1118300, 1131670, 1166750, 1225140, 1169280, 1176450, 1207660, 1271450, 1231880, 1202550, 1162640, 1128680, 1177600, 1186090, 1195020, 1172120, 1169660, 1133450, 1164890, 1139520, 1175230, 1126700, 1162640, 1147490, 1081840, 1201160, 1161670, 1164500, 1145080, 1168350, 1184810, 1224820, 1161180, 1168600, 1108720, 1190080, 1183960, 1163350, 1133240, 1153940, 1150980, 1150540, 1112750, 1100700, 1095540, 1127150, 1141450, 1123480, 1176770, 1158120, 1167160, 1107560, 1088000, 1054190, 1106960, 1026410, 1005700, 1057340, 1106610, 1127690, 1149280, 1150750, 1121120, 1114070, 1130140, 1181800, 1136910, 1146190, 1185990, 1179820, 1213350, 1263920, 1143860, 1203840, 1169620, 1107010, 1178910, 1157010, 1193740, 1173170, 1138990, 1102060, 1097460, 1086180, 1108620, 1153560, 1099400, 1084830, 1089520, 1051480, 1154250, 1186530, 1162100, 1111340, 1085450, 1108340, 1118400, 1090510, 1074700, 1100600, 1111180, 1061230, 1094820, 1091760, 1040260, 1114620, 1142190, 1123800, 1152480, 1140520, 1176810, 1185940, 1189290, 1177740, 1120030, 1145910, 1145500, 1176380, 1138330, 1219160, 1168640, 1117360, 1120850, 1135690, 1162530, 1121540, 1211100, 1199780, 1144730, 1087050, 1098820, 1125800, 1179480, 1155530, 1083980, 1102600, 1093940, 1053930, 1082410, 1106540, 1124490, 1145050, 1098780, 1168250, 1160700, 1177540, 1142150, 1108700, 1132590, 1138600, 1126000, 1091800, 1031700, 1077560, 1102100, 1076910, 1040590, 1089350, 1119250, 1121620, 1162100, 1192840, 1183370, 1155490, 1160180, 1184780, 1195200, 1191210, 1138970, 1082750, 1150040, 1078880, 1080410, 1054040, 1107540, 1116450, 1093750, 1102150, 1112910, 1050250, 1083100, 1083080, 1078390, 1058690, 1059590, 1138470, 1089680, 1052580, 1060160, 1051850, 1034670, 1037320, 1071730, 1046000, 1061740, 1068410, 1061120, 1077220, 1103530, 1096090, 1105420, 1086690, 1099690, 1100110, 1165500, 1135630, 1080030, 1074280, 1107080, 1094400, 1158960, 1160530, 1158830, 1141850, 1065100, 1031250, 1063010, 998530, 1042660, 1008610, 1039800, 1096750, 1077640, 1081980, 1086370, 1058900, 1067980, 1081920, 1110700, 1023300, 1059570, 1067270, 1087980, 1131810, 1125620, 1104370, 1143890, 1109020, 1153140, 1181640, 1179860, 1178750, 1136910, 1124540, 1110910, 1198300, 1191280, 1173740, 1118640, 1061700, 1144660, 1134560, 1107460, 1118350, 1153660, 1196530, 1150970, 1139500, 1050830, 1052790, 1099950, 1114320, 1109050, 1072730, 1055850, 1092440, 1128440, 1141610, 1085390, 1122790, 1149350, 1174680, 1130370, 1116490, 1120630, 1153680, 1130820, 1152100, 1156160, 1137700, 1206470, 1146520, 1152550, 1121750, 1078200, 1125220, 1151090, 1164330, 1090830, 1043640, 1060590, 1054230, 1112000, 1092120, 1167000, 1199040, 1115880, 1138020, 1180110, 1114170), `1983` = c(918667, 910547, 909942, 859855, 840808, 842840, 939144, 959902, 933307, 942529, 955197, 930946, 821139, 837923, 887843, 995960, 903878, 929581, 900544, 948986, 1042810, 1000280, 1042880, 1086910, 1004920, 916280, 1010330, 947917, 935271, 937036, 922286, 859339, 896826, 906126, 887133, 915884, 925255, 1018240, 1033920, 1008080, 1024480, 984729, 945398, 902533, 883272, 907211, 885451, 871096, 829188, 864232, 907361, 912568, 936695, 948957, 947212, 835617, 917633, 983050, 942754, 929780, 900135, 981224, 932032, 954204, 903685, 930376, 944298, 959683, 884909, 884485, 909882, 854048, 873317, 935401, 857391, 918147, 884647, 899374, 872973, 926672, 873733, 943603, 883460, 912734, 885901, 889496, 980546, 1033840, 992039, 979085, 1000760, 1019410, 1052950, 983033, 1008230, 1003120, 969252, 979367, 956216, 924313, 951392, 982983, 893499, 919012, 929271, 924656, 858708, 885451, 895002, 885897, 826728, 887015, 888902, 901012, 870117, 868287, 820762, 862073, 964723, 965901, 852340, 841580, 799992, 814066, 866339, 871033, 882362, 902327, 1006610, 956199, 1011130, 991326, 1012680, 976386, 1016120, 955708, 940171, 971791, 897732, 931915, 899308, 929124, 935054, 934781, 984739, 964926, 997586, 871305, 915242, 966981, 1004460, 971197, 928753, 995319, 1027760, 1026830, 936911, 954705, 930671, 928250, 881698, 884897, 919200, 935134, 951614, 925515, 925308, 943162, 962662, 979135, 940078, 927722, 996713, 947332, 961719, 948291, 921756, 955842, 912075, 927015, 1000130, 956374, 937191, 907973, 876723, 864815, 857276, 896519, 913043, 884283, 872263, 862819, 879737, 871041, 884275, 833816, 852494, 883633, 869513, 878814, 852244, 904728, 957056, 889741, 863493, 920941, 871038, 867547, 873486, 870257, 863774, 855923, 847734, 908065, 932889, 864283, 869702, 860932, 850902, 874031, 871317, 889464, 840579, 901668, 927697, 886980, 963964, 917375, 905040, 889850, 886138, 855133, 900284, 876421, 923017, 939959, 939246, 893323, 880878, 935276, 841640, 905518, 953806, 890308, 882732, 961949, 861534, 918001, 878538, 898061, 880274, 910789, 919746, 913482, 972504, 939333, 987218, 1016020, 959407, 949200, 892158, 889453, 958481, 970632, 939883, 982369, 951650, 958469, 963986, 983681, 1023860, 924895, 878488, 860340, 896760, 926001, 930183, 930988, 887384, 916964, 881616, 827734, 911276, 932791, 914312, 877088, 886258, 872570, 820197, 825523, 828140, 860825, 841589, 829887, 952689, 989823, 1015650, 930350, 952277, 921124, 888011, 861740, 907100, 913031, 912643, 923611, 867266, 878147, 936663, 976031, 992808, 979706, 923414, 938547, 938557, 848488, 859473, 920004, 898971, 895392, 862898, 805825, 934627, 903965, 948573, 946248, 962279, 991484, 870228, 850411, 901309, 969132, 920496, 905414, 937322, 940177, 943269, 952145, 901989, 948521, 933399, 975439, 947759, 935463, 916639, 949768, 968556, 914509, 917923, 973804, 922643, 902160, 959092, 1005290, 1008610, 960804, 937248, 940620, 943938, 883076, 865207, 933327, 976655, 1031360, 1058880, 961778, 985520, 955971, 969862, 1009900, 987190, 989273, 921276, 920787, 930174, 911838, 933313, 922596, 914878, 957902, 876257, 895926, 952150, 923919, 926859, 923527, 927735, 928503, 892828, 995379, 947679, 977435, 976625, 942105, 913597, 882141, 917246, 907299, 891486, 941529, 941772, 800099, 815841, 930200, 941128, 884464, 923812, 879379, 913911, 949058, 993731, 1045280, 1034540, 1025430, 975916, 978428, 999859, 994841, 971176, 888858, 930654, 971434, 968925, 949892, 916630, 910537, 949595, 937921, 921616, 867339, 848929, 888155, 935703, 979187, 1019290, 939381, 970216, 930167, 972908, 1002400, 941191, 897028, 938975, 1014710, 973042, 937481, 962471, 935152, 894708, 876568, 888610, 878759, 851327, 883246, 885535, 877965, 813763, 879522, 929322, 894965, 875978, 906463, 914528, 951854, 938087, 935876, 999789, 959834, 956210, 940989, 924133, 910287, 932110, 919401, 911574, 898545, 958730, 954123, 869671, 943348, 964127, 909025, 892257, 914355, 855567, 855702, 854819, 897586, 928634, 960708, 937632, 955937, 957025, 881919, 903680, 849585, 820907, 881141, 864511, 901470, 950156, 877998, 965669, 900428, 843767, 874745, 919159, 924631, 909799, 937237, 911225, 906605, 885593, 809754, 895999, 908730, 929276, 970930, 977638, 949401, 956915, 927276, 932375, 948427, 945532, 936130, 939861, 912497, 880130, 919125, 927849, 970948, 1055270, 1026500, 985925, 974360, 982399, 925458, 908299, 943412, 948032, 940892, 949360, 936426, 903015, 925445, 942133, 927179, 930672, 912620, 888051, 912387, 864840, 886503, 906918, 929537, 918701, 917969, 847099, 904589, 989391, 920948, 930179, 960171, 986318, 983460, 919676, 898713, 902801, 917170, 912362, 847061, 845588, 897543, 876028, 964184, 987059, 944312, 925017, 894575, 867588, 879958, 889496, 870307, 845288, 854748, 913936, 888492, 890436, 905451, 907420, 905456, 935991, 969840, 975440, 947622, 867392, 934079, 887666, 892083, 923997, 958925, 963207, 890248, 951186, 943646, 948268, 951393, 912554, 977743, 919811, 895960, 910260, 909369, 975736, 954341, 939240, 977999, 966727, 938614, 920973, 1007890, 953526, 957016, 929140, 930453, 998118, 912251, 920108, 989153, 1045000, 1017550, 959262, 980551, 1027410, 947062, 940783, 942126, 837459, 866022, 878320, 895351, 858989, 894215, 867868, 883938, 856732, 823881, 888770, 906134, 912722, 935772, 905263, 889640, 900278, 875054, 825739, 892575, 920105, 972104, 960363, 892918, 880336, 840412, 910178, 915242, 879987, 849759, 883534, 890549, 872077, 905716, 926147, 939382, 919479, 961918, 933383, 846676, 852364, 916236, 840896, 792093, 820500, 815606, 876403, 865291, 852745, 837287, 855969, 831306, 845224, 849725, 883729, 926927, 916815, 944420, 908005, 839642, 885895, 876935, 885207, 898144, 916533, 1002510, 949576, 935576, 963358, 1022180, 975078, 950961, 943272, 899457, 959042, 986604, 976398, 947248, 933284, 898610, 921735, 914942, 942017, 881166, 903613, 879955, 819737, 931703, 894389, 900946, 902107, 937767, 951095, 960041, 908839, 932155, 865217, 941375, 923479, 896501, 889724, 936999, 946339, 955756, 927120, 912571, 908747, 937349, 964882, 912471, 993665, 955598, 978131, 893119, 896546, 828844, 892837, 835386, 812417, 872018, 917187, 922758, 961863, 927637, 914074, 908433, 930057, 973734, 954980, 956651, 973410, 988607, 1013390, 1089030, 964503, 1022490, 971697, 901382, 968437, 958994, 1004050, 986790, 922464, 865058, 870214, 867854, 887498, 924275, 872469, 869588, 857756, 817980, 923610, 964840, 943711, 880945, 847964, 885253, 883534, 869991, 878896, 923291, 924365, 897950, 956639, 929779, 860518, 919874, 936257, 930733, 931383, 911396, 924607, 948419, 972368, 974827, 920521, 906830, 907449, 955677, 929287, 1018030, 947969, 892431, 899241, 923193, 922360, 877940, 973864, 976448, 953455, 907636, 936571, 900973, 953012, 984395, 872300, 862410, 885910, 848132, 847556, 874316, 893027, 903071, 851972, 921815, 980647, 986173, 944831, 887871, 875745, 870847, 873082, 834905, 811922, 870298, 895649, 860714, 827873, 880338, 892338, 903563, 980869, 993222, 948715, 948173, 964272, 988043, 1011590, 973404, 932339, 875923, 939319, 891710, 909434, 899593, 912741, 918924, 887566, 895463, 894017, 815448, 884780, 873620, 894504, 853621, 863392, 929579, 890993, 844935, 857598, 841632, 819286, 824880, 857971, 824690, 862980, 865185, 860043, 872559, 894698, 899778, 890024, 893026, 879788, 886901, 938169, 924834, 852019, 840883, 876874, 875575, 943886, 926146, 917765, 916379, 864710, 821957, 849715, 806935, 835072, 812078, 832078, 884370, 911400, 873567, 862268, 863430, 866492, 879431, 910115, 804396, 811963, 835491, 859873, 915265, 931320, 898477, 924066, 880763, 898338, 938388, 924763, 955412, 934841, 912292, 897216, 967953, 970040, 935808, 888782, 847057, 923007, 878794, 859861, 894447, 915167, 931815, 914111, 951145, 848550, 856854, 904465, 916110, 893854, 848637, 860359, 882332, 921468, 929011, 861587, 909885, 952106, 988972, 929745, 914016, 934049, 964434, 906880, 914411, 929279, 923990, 987308, 923477, 942395, 956575, 874679, 916281, 951387, 991566, 938034, 868186, 882627, 902087, 907636, 863756, 945794, 986608, 911096, 937474, 952648, 910945), `1984` = c(1002060, 1000070, 1019910, 965531, 948761, 944650, 1011870, 1058170, 1050910, 1038020, 1000010, 1007300, 952800, 973240, 1006110, 1086190, 972950, 998612, 992277, 1018500, 1099870, 1072070, 1115260, 1156830, 1070370, 1038790, 1106410, 1054710, 1030360, 1047140, 1044980, 987411, 993393, 984583, 964019, 996278, 1043880, 1095360, 1090880, 1085600, 1118550, 1058330, 1029530, 981273, 967244, 972289, 908978, 939688, 925841, 964304, 1038510, 1002900, 1005480, 1012960, 1024090, 942840, 1009880, 1095800, 1052540, 1022630, 1001880, 1090740, 1033630, 1033370, 952437, 1006710, 967599, 983209, 942773, 923522, 976983, 908515, 889088, 983970, 976540, 972205, 947159, 956564, 938003, 1046860, 1002170, 1003760, 967155, 951536, 921508, 980382, 1130260, 1087770, 1016790, 1003050, 1040020, 1074120, 1120930, 1035360, 1067960, 1061520, 1057190, 1056000, 1048090, 1025860, 1017110, 1086080, 974165, 1006650, 1011590, 1022430, 988790, 1015250, 1007000, 1020160, 945176, 976879, 968203, 949101, 952679, 944642, 895421, 932820, 1017480, 1017970, 915367, 910908, 888370, 960340, 1003700, 990789, 993323, 1008380, 1146480, 1164130, 1202360, 1087780, 1099320, 1083870, 1088680, 1019340, 1009680, 1050350, 994209, 1039910, 1017990, 1009820, 1035500, 985882, 1008020, 976167, 1033160, 932432, 1015700, 1067100, 1077590, 1028980, 997666, 1070560, 1105100, 1083760, 999734, 1001750, 1000910, 983770, 935295, 938057, 938886, 1047490, 1029300, 1012250, 1068740, 1067240, 1100280, 1146630, 1100930, 1106420, 1114040, 1081360, 1081180, 1040280, 1027710, 1043480, 995498, 1033620, 1080840, 1041330, 1035320, 1011650, 969177, 964845, 936471, 976931, 991124, 980054, 966276, 915520, 955758, 929735, 971236, 941316, 962117, 955609, 934070, 917110, 894117, 936079, 972049, 912943, 967944, 1002480, 963939, 954871, 945323, 959084, 995638, 955895, 959761, 1004780, 1025780, 946690, 953301, 945489, 934770, 970068, 963373, 1029290, 941854, 986535, 1034640, 1013990, 1077870, 1059990, 1016650, 1011600, 976862, 970673, 994157, 996447, 1005130, 972913, 971831, 972654, 969194, 1026250, 900974, 961799, 974164, 912489, 964487, 1010380, 925106, 1001880, 921212, 963308, 992332, 1018740, 1002800, 981644, 1024920, 986411, 1042940, 1045100, 1006810, 983494, 940017, 966286, 1016720, 1062720, 1010600, 1084520, 1059180, 1058150, 1055990, 1075310, 1122120, 1007100, 978034, 948301, 981054, 1034510, 1059390, 1050070, 975140, 987022, 953130, 927067, 1029230, 1053560, 1025570, 945197, 979755, 965835, 929000, 913568, 880032, 914797, 874514, 872814, 952435, 1039780, 1057400, 972737, 985538, 963560, 952365, 967654, 967085, 1009300, 1001870, 1002970, 939424, 961496, 993708, 1043400, 1034590, 1013790, 966220, 1006150, 1010730, 945950, 959092, 1006380, 959388, 976911, 975416, 917283, 1034290, 1024170, 1092870, 1070110, 1039870, 1094860, 1010020, 978208, 989551, 1033610, 975283, 942239, 991141, 1040220, 1069460, 1045260, 977570, 1021290, 993779, 1043680, 1002780, 1006650, 1018160, 1058270, 1075090, 1034720, 1028840, 1106030, 1037680, 980136, 1036220, 1054160, 1064820, 1066480, 1040140, 1050100, 1032520, 972825, 961377, 1055090, 1104840, 1149690, 1161060, 1034270, 1057340, 1025510, 1036080, 1052490, 1044760, 1050600, 977542, 974752, 983178, 991945, 1013570, 1006900, 1022880, 1063540, 931007, 958913, 1012620, 992611, 1039120, 1059360, 1021670, 1044630, 1016310, 1073480, 1031420, 1047000, 1015800, 984067, 985589, 958547, 1010100, 994336, 975250, 1003440, 1031000, 917528, 933645, 1036900, 1036060, 986511, 1044260, 969007, 951850, 978210, 1002300, 1085920, 1114810, 1123160, 1066220, 1029160, 1075700, 1066110, 1047420, 952192, 983989, 1041090, 1004740, 996400, 984392, 995661, 1005890, 979081, 968419, 909893, 895264, 900240, 971567, 1010150, 1081680, 1024420, 1037110, 1030740, 1080700, 1106240, 1037600, 982443, 1013020, 1082860, 1048600, 1011000, 1030080, 1034940, 1000020, 972236, 998366, 963267, 940645, 985633, 1004530, 973004, 942117, 991922, 1048370, 1032330, 987941, 1002420, 974970, 987184, 989594, 981024, 1102600, 1077120, 1075210, 1052520, 1039230, 1041220, 1075600, 1037110, 1012540, 987678, 1051020, 1046650, 995131, 1065690, 1045720, 1021480, 1028060, 1051130, 980171, 994780, 1007690, 1011390, 1033600, 1088250, 1029170, 1016400, 1027110, 952150, 976119, 889376, 875692, 954911, 974542, 1015320, 1062620, 1003040, 1048920, 984755, 914052, 990860, 1033010, 1012560, 1010780, 1016940, 1027560, 1022050, 996303, 927519, 986078, 999131, 994760, 1043930, 1052670, 1050600, 1035500, 990602, 1016770, 1043220, 1025110, 1001090, 1019790, 1023410, 995549, 1054810, 1074960, 1118560, 1162050, 1126380, 1097610, 1067110, 1078840, 982464, 961653, 995831, 1028590, 1029130, 1062770, 1040050, 996070, 1022580, 1014530, 975105, 987389, 1007350, 1003510, 1014190, 970182, 993585, 1040550, 1035720, 1042740, 1037310, 982290, 1052470, 1091100, 1017270, 1045720, 1065270, 1089950, 1074520, 1019770, 1004000, 975143, 998667, 985934, 937337, 944875, 986998, 975722, 1043660, 1047770, 1012310, 1008410, 948620, 963653, 950474, 973535, 967643, 951105, 946034, 1020040, 999877, 963283, 955224, 1019060, 1003990, 1036070, 1042780, 1035340, 1004180, 930005, 1021550, 971515, 1028890, 1057990, 1070390, 1082340, 1022240, 1058550, 1048420, 1030540, 1008510, 997656, 1092250, 1009940, 968578, 983030, 985651, 1035850, 1016190, 1036180, 1054260, 1037990, 998450, 961117, 1014000, 987142, 1005250, 935534, 987281, 1068200, 988796, 1011060, 1081630, 1204510, 1174130, 1104850, 1145650, 1156670, 1101950, 1057390, 1041430, 963678, 964411, 977223, 1029880, 957333, 1006210, 980505, 986562, 928671, 891170, 960389, 986654, 988312, 993995, 965063, 973837, 1011890, 967299, 958583, 969560, 997429, 1046230, 1081650, 942295, 926946, 896855, 1002520, 1025350, 984599, 930811, 951037, 984030, 963101, 990648, 984514, 987183, 980132, 982876, 928110, 926459, 952037, 1039370, 974626, 895326, 915669, 907458, 962938, 931751, 934971, 916106, 978791, 940541, 942729, 916563, 945785, 1002240, 1002390, 1000650, 975646, 894010, 943385, 927707, 990070, 965986, 990821, 1083290, 1044040, 1024740, 1057180, 1096340, 1064020, 1001450, 1037240, 968369, 1054030, 1020780, 1010140, 1017800, 974076, 934358, 929015, 920560, 971965, 921618, 947473, 944315, 900384, 1007240, 961140, 973046, 979823, 984544, 999374, 1006890, 976487, 1024240, 1004240, 1032340, 1050030, 994178, 948900, 1020730, 1026140, 1037640, 1001650, 968146, 984364, 1001260, 1016680, 971941, 1037490, 984805, 1050670, 961407, 972363, 903925, 934919, 949805, 936616, 984350, 1045790, 1024000, 1052610, 986799, 979463, 988785, 1007240, 1035630, 1021130, 1003140, 1013410, 1028940, 1082490, 1152950, 995820, 1075220, 1039420, 985845, 1049760, 1046560, 1103480, 1100900, 989482, 955410, 960954, 947264, 951160, 998621, 941193, 915580, 927641, 872894, 956655, 1015280, 1001590, 985723, 943053, 1047790, 1017340, 957192, 964104, 1038120, 1029960, 1010850, 1046090, 995615, 931798, 996838, 1014800, 1018570, 951729, 967112, 1018050, 1012750, 1035050, 1045950, 988856, 968771, 970743, 1030310, 1055360, 1141010, 1075840, 1065320, 1091440, 1048830, 1021920, 1005390, 1056350, 1019950, 1018270, 1007800, 998955, 953700, 1018710, 1074550, 948261, 933755, 963827, 907303, 932266, 914722, 961189, 975633, 966402, 1009100, 1040620, 1024720, 965553, 894419, 914940, 929924, 967878, 943255, 898726, 965814, 974021, 919532, 919919, 936128, 946241, 951070, 1061750, 1077220, 1048620, 1060040, 1068520, 1100650, 1113960, 1088460, 1013890, 967046, 1045600, 996194, 1029060, 999818, 983564, 994237, 951439, 967308, 995876, 916471, 993239, 997987, 999109, 974806, 986397, 1028770, 1013760, 958635, 944569, 928161, 901993, 894981, 923108, 835117, 904889, 926292, 924134, 941163, 984504, 1021650, 981095, 998056, 946780, 943111, 1018230, 1001650, 973420, 981527, 967898, 987276, 1031930, 998472, 983171, 989772, 999518, 926283, 990677, 928979, 962277, 926734, 964293, 977603, 1020990, 979672, 976001, 985040, 963059, 963625, 970406, 886886, 927918, 937694, 929209, 1011550, 1025520, 973821, 1015490, 960269, 932757, 965094, 1000610, 1038290, 1052300, 1057030, 1030130, 1077030, 1038040, 1010310, 958227, 923529, 960445, 924374, 927915, 953151, 943000, 1010900, 1000050, 1062900, 986685, 964139, 1014200, 1028180, 1033280, 994306, 1008440, 981723, 1024770, 1017880, 932074, 959759, 986038, 1045800, 975900, 967200, 990215, 1002920, 963276, 984368, 1002520, 1015110, 1061420, 992617, 999764, 1049270, 944453, 1029590, 1048560, 1097350, 1034690, 1008070, 1008230, 1020830, 973289, 934542, 1020000, 1067910, 1005980, 1024190, 1037440, 961683), `1985` = c(1021350, 1094380, 1075070, 987114, 973063, 973693, 1025740, 1089890, 1091160, 1089390, 1040070, 1048990, 972511, 969105, 1020960, 1074130, 990345, 1027930, 1015560, 1012700, 1126790, 1086510, 1127310, 1162430, 1107010, 1080820, 1116200, 1066190, 1026080, 1033950, 1069630, 1023720, 1036370, 1020110, 973912, 958206, 1046400, 1117560, 1114860, 1076690, 1124310, 1097370, 1093170, 1035730, 1029180, 1023470, 952366, 981441, 900906, 974902, 1068540, 1089430, 1078310, 1029700, 1073150, 959650, 1026120, 1094100, 1108780, 1068640, 1065840, 1135110, 1051260, 1015290, 914474, 999444, 983531, 994673, 984277, 956055, 975942, 924714, 951946, 1023250, 1034700, 1012020, 970878, 981319, 964318, 1081650, 1038870, 1024770, 1011250, 950448, 959805, 1041410, 1165210, 1078220, 1020090, 1023960, 1052810, 1097000, 1168560, 1047690, 1103150, 1105790, 1075220, 1053260, 1052200, 1021280, 1015330, 1065580, 969482, 1008330, 1016440, 1018810, 1013630, 1017550, 996448, 1083160, 1006710, 1003050, 949585, 947833, 976621, 981975, 942446, 958572, 1008430, 1028020, 932933, 958389, 957189, 1010120, 1024810, 1011560, 986275, 982699, 1131820, 1163460, 1189070, 1059490, 1071040, 1042100, 1063980, 984189, 968604, 1010800, 974617, 1025090, 1017950, 1014070, 1058820, 1021690, 1032530, 1008240, 1041650, 962771, 1073480, 1110040, 1106080, 1070130, 1077220, 1081240, 1093040, 1108080, 1013760, 1013040, 1045950, 1031020, 963675, 973839, 985651, 1057970, 1056020, 1053990, 1081800, 1080960, 1105200, 1145340, 1102460, 1132320, 1158210, 1091660, 1116620, 1082840, 1073900, 1059970, 1011780, 1031290, 1089770, 1061190, 1053050, 1035530, 1004970, 988375, 996608, 1024580, 1021060, 1037150, 1003650, 971503, 1037630, 968187, 985694, 963930, 969936, 962453, 968391, 971953, 953983, 985726, 1028720, 949203, 1016640, 1061440, 1039520, 1023130, 987646, 1018860, 1079820, 1012430, 1024700, 1031380, 1029280, 959031, 975973, 957534, 947313, 1041970, 1046850, 1121460, 1035420, 1087650, 1116140, 1086410, 1120850, 1086580, 1037050, 1053690, 1028480, 1040130, 1063570, 1033070, 1052790, 1018660, 1014970, 1020270, 1033830, 1080710, 976212, 983542, 981598, 904104, 999984, 1059650, 996017, 1071540, 964148, 989639, 1023290, 1062710, 1045780, 1013440, 1052260, 984970, 1041230, 1091990, 1044260, 963554, 932622, 952105, 1011260, 1053180, 1022280, 1109440, 1091150, 1063540, 1083840, 1083090, 1139820, 1013040, 1013480, 974725, 1001930, 1069390, 1117970, 1097210, 995126, 977550, 935763, 904683, 1044110, 1078300, 1037190, 988199, 989489, 965022, 920824, 954745, 979061, 996901, 990552, 1027770, 1075380, 1125720, 1086880, 969120, 970127, 987197, 957061, 992497, 987145, 1015700, 1007820, 1029150, 1007460, 1019450, 1062030, 1089670, 1044850, 1045430, 987250, 1022230, 1041870, 982792, 975530, 982708, 923479, 978494, 1004990, 933605, 1064240, 1026180, 1057950, 1081520, 1054500, 1121240, 1053840, 1013340, 1045310, 1092370, 1061510, 969887, 993582, 1080250, 1124450, 1076530, 1032080, 1043030, 994263, 1031420, 1028260, 1075380, 1085270, 1114850, 1162250, 1106660, 1120720, 1195560, 1099060, 987625, 1043750, 1064360, 1097830, 1112930, 1101810, 1108750, 1070210, 1000550, 997085, 1093050, 1126410, 1137260, 1154320, 1054840, 1088910, 1048100, 1035780, 1049050, 1044170, 1073770, 1046770, 1037360, 1018160, 1019670, 1052540, 1015970, 1038530, 1050750, 964648, 982171, 995989, 971132, 1055050, 1044020, 1024210, 1013750, 970807, 1062790, 1021700, 1018670, 992888, 987706, 1013390, 985318, 1027200, 1017820, 975087, 1026090, 1072620, 985271, 985499, 1077450, 1104670, 1052110, 1062480, 1018590, 993447, 1007210, 1028360, 1144940, 1134730, 1143590, 1101740, 1060590, 1071910, 1068450, 1046740, 980701, 991895, 1036340, 997469, 1006250, 1040440, 1074270, 1074770, 1021270, 992203, 957090, 951398, 965087, 1027680, 1020400, 1053860, 1016910, 1040100, 1006720, 1035610, 1060770, 1026040, 944957, 977938, 1083530, 1046120, 996885, 1005470, 1005580, 956758, 934797, 959650, 948261, 919106, 968707, 1018080, 960160, 966815, 1017230, 1067570, 1043710, 1041710, 1051520, 998942, 996127, 1000090, 1003090, 1142990, 1098880, 1082720, 1076940, 1051450, 1108110, 1111560, 1075310, 1040020, 978974, 1034260, 1027080, 970152, 1044030, 1012940, 1028540, 1051980, 1074050, 1028290, 1010180, 1025790, 1080130, 1081750, 1098850, 1051130, 1046270, 1064790, 1017520, 1019990, 929261, 908845, 996654, 1031230, 1072100, 1098600, 1020800, 1059540, 1006190, 954043, 1013300, 1043050, 1020990, 1036320, 1013450, 1027040, 1026300, 990808, 944690, 1007830, 1017830, 1043830, 1091640, 1079290, 1074640, 1034330, 980110, 1014150, 1014900, 999732, 1006570, 1016210, 989046, 979080, 1027110, 1035650, 1095850, 1150240, 1134410, 1109500, 1069650, 1084630, 998536, 958228, 990056, 1039020, 1019260, 1048210, 1030770, 984440, 1002270, 1002180, 968861, 977800, 983742, 1014870, 1023130, 998214, 1034560, 1091750, 1086080, 1091220, 1090960, 1031510, 1120080, 1094830, 1037150, 1038530, 1062460, 1101970, 1100540, 1024150, 1015500, 977806, 991393, 979655, 961059, 967017, 985361, 978888, 1031240, 1031530, 1038990, 1015620, 971778, 1004890, 1013410, 984079, 1005480, 1010500, 1024450, 1098150, 1050260, 1056410, 1033820, 1052820, 1040050, 1022520, 1041460, 1028050, 1000150, 963189, 1079730, 1007590, 1037480, 1114400, 1105130, 1095670, 1034360, 1055570, 1038020, 1056920, 996605, 1012860, 1109360, 1036470, 965899, 987049, 994115, 1049690, 1021790, 1048170, 1073090, 1047180, 1039650, 980708, 1019200, 1022080, 1011630, 956812, 1020800, 1057420, 979309, 1000090, 1060140, 1181830, 1147560, 1063190, 1108890, 1112520, 1050190, 1044170, 1010290, 938725, 928339, 962172, 1035520, 977547, 1026760, 986437, 987593, 915011, 863238, 950057, 1004700, 1004950, 1012450, 983121, 962726, 998245, 955366, 948180, 991555, 992652, 1044960, 1111840, 934334, 927439, 894302, 1016000, 1035360, 962097, 923702, 922655, 957903, 950035, 952383, 984975, 978817, 1003750, 972248, 943131, 975546, 983827, 1066840, 1010940, 950795, 923771, 904508, 950843, 936727, 944270, 930238, 994412, 954915, 970893, 923171, 947030, 1029170, 1007800, 1005950, 990951, 921052, 1006990, 955148, 1013100, 1044860, 1055270, 1140630, 1104570, 1060340, 1061280, 1110900, 1117780, 1036570, 1075780, 987361, 1094710, 1061260, 1037140, 1070250, 1028990, 962958, 928535, 929829, 975985, 934909, 977305, 1027830, 967497, 1078620, 1015300, 999076, 987125, 1040650, 1049210, 1028540, 982018, 1023730, 1036630, 1092760, 1065870, 1006700, 957952, 1010060, 1017950, 1039250, 988225, 952003, 961576, 999134, 1045360, 969353, 1057470, 995324, 1066930, 1016220, 1013680, 971464, 1036200, 1020840, 1007130, 1046580, 1076960, 1024870, 1052460, 996002, 1012310, 1000680, 1012040, 1059650, 1036040, 1025480, 1056310, 1112870, 1172700, 1209070, 1041780, 1078670, 998526, 948174, 1002120, 996399, 1096340, 1136310, 1005120, 1025730, 982068, 987001, 1008190, 1011640, 1014480, 982269, 966615, 958693, 1042710, 1072710, 1065520, 1045210, 1029820, 1077670, 1075100, 1030000, 1004910, 1055870, 1057640, 1020730, 1055680, 1001120, 944426, 1020620, 1003540, 1047560, 975863, 1001900, 1041020, 1042630, 1036270, 1044160, 991149, 985303, 959085, 1019410, 1068310, 1167850, 1113730, 1098410, 1123700, 1055920, 1049340, 1046190, 1066840, 1013110, 1039630, 1035280, 1027500, 972646, 1041290, 1083860, 943497, 939263, 925922, 895484, 924893, 908381, 940647, 979819, 975334, 989437, 1049330, 1036320, 995692, 924946, 957673, 961002, 994157, 981129, 934094, 996533, 990682, 934747, 936881, 959346, 949600, 951798, 1047620, 1066040, 1033030, 1050740, 1069720, 1079700, 1084390, 1080900, 1026220, 976325, 1050660, 1016100, 1070870, 1060710, 1032110, 1016690, 944477, 1000140, 998698, 932323, 986721, 1001040, 999385, 974750, 998157, 1030400, 1041420, 958477, 974992, 953719, 934677, 961219, 952854, 859902, 894356, 917134, 907929, 921901, 981703, 1011100, 950495, 998588, 941956, 941326, 1020610, 1015780, 992481, 1009180, 982969, 977691, 1025550, 983567, 996259, 1011710, 1025550, 988758, 1063910, 987506, 1037350, 1009630, 1018400, 992452, 1030330, 1042830, 1048460, 1023910, 979924, 976993, 978045, 917488, 986238, 995352, 989671, 1044690, 1035300, 974210, 1018240, 1004530, 986418, 986915, 1037130, 1079440, 1081050, 1100430, 1048930, 1084900, 1048730, 1004660, 974386, 936034, 990043, 968562, 935786, 989651, 985573, 1043350, 1015710, 1116720, 999926, 990624, 1025660, 1042560, 1068800, 1005840, 1030040, 993396, 1034240, 1026910, 951319, 962531, 975040, 1044660, 992075, 1002770, 987471, 1014530, 964335, 975950, 1029140, 1046920, 1078910, 1004200, 1021770, 1099020, 996749, 1080480, 1056870, 1115110, 1045150, 1032830, 1015060, 1058140, 1008420, 955950, 1039200, 1084570, 1027330, 1041160, 1058540, 959970), `1986` = c(900452, 980215, 940919, 832983, 820954, 820114, 866687, 948293, 945105, 959374, 895054, 909743, 851263, 865685, 870168, 919835, 868633, 909806, 910604, 855186, 973113, 917401, 946400, 1010060, 964870, 938426, 972213, 914138, 883336, 890478, 917799, 880808, 880158, 887385, 853117, 866166, 932451, 999094, 988188, 928786, 990176, 944501, 971230, 936685, 907432, 900347, 835318, 893811, 790929, 890221, 951203, 993254, 1007740, 887592, 921938, 812963, 905700, 991368, 995392, 950993, 979921, 1014530, 933120, 896940, 813641, 870320, 865756, 884714, 870907, 848517, 849254, 802664, 808168, 898427, 884961, 851534, 843350, 812802, 826918, 920973, 892198, 870941, 863970, 838073, 852274, 941157, 1060100, 970301, 879714, 902638, 937687, 963912, 1031460, 909383, 986845, 1011010, 994008, 973484, 930551, 935140, 934092, 934330, 858977, 928096, 950288, 912922, 884618, 893104, 858227, 958202, 868742, 849901, 810211, 821057, 849144, 866626, 830177, 848343, 907760, 926057, 845520, 843441, 831423, 874470, 877463, 868838, 844538, 803883, 963916, 1035990, 1045740, 941766, 919095, 917767, 890306, 831618, 801156, 840289, 820167, 871240, 859454, 855877, 886816, 893010, 897521, 900652, 937293, 855047, 989393, 1029540, 986408, 928742, 935278, 946540, 946649, 945081, 875837, 872761, 947721, 895031, 841538, 874921, 831612, 885679, 908787, 901179, 949926, 954829, 980788, 1000490, 954815, 990465, 1022940, 981759, 991846, 968308, 955464, 932099, 899775, 917721, 963261, 939238, 952107, 941870, 896476, 901036, 892612, 905621, 909687, 919150, 893516, 865999, 944303, 904509, 892396, 883517, 882157, 836367, 874017, 867939, 844443, 839604, 894004, 841051, 958616, 986196, 964175, 908330, 872539, 912187, 968809, 869902, 925235, 934525, 924332, 889168, 920286, 885503, 870786, 958679, 958705, 1032490, 947801, 954416, 957311, 907697, 930025, 894730, 881004, 912695, 909122, 911942, 906774, 877695, 933530, 897743, 883060, 888837, 898204, 914668, 843255, 853305, 892899, 834690, 903235, 950835, 875382, 899386, 814551, 844230, 858711, 882279, 897475, 858774, 888869, 838586, 891804, 954089, 910119, 829973, 836101, 823432, 908716, 927414, 900771, 980787, 963575, 934982, 930447, 949189, 1010600, 861522, 906936, 869422, 903639, 939227, 1001070, 1017090, 961770, 926960, 911381, 842249, 949085, 984371, 946503, 906252, 874801, 848973, 802626, 848233, 879804, 906522, 872955, 915857, 957506, 999944, 975068, 831107, 840009, 887067, 881443, 934088, 878196, 921329, 895008, 902003, 888600, 932393, 958782, 959059, 902392, 898700, 841546, 912437, 950982, 900793, 884029, 829501, 769200, 849679, 879026, 819482, 948939, 910276, 919668, 949528, 917556, 983400, 935878, 849727, 885930, 957379, 908644, 862901, 852339, 928679, 957751, 920403, 869153, 880658, 866071, 902641, 927300, 960639, 958025, 989881, 1023490, 975516, 987408, 1054600, 973668, 862405, 886353, 880196, 913320, 933282, 930628, 955905, 919595, 877847, 887098, 960045, 982606, 978658, 994257, 922370, 973377, 939986, 910682, 908835, 888392, 936369, 914081, 915918, 900239, 881226, 935028, 909733, 923632, 936510, 857283, 899526, 865425, 841504, 933973, 887123, 873761, 905042, 867227, 933439, 940222, 905769, 880483, 894918, 922797, 902828, 961459, 920963, 882499, 895705, 935784, 863771, 861087, 956725, 1000490, 950887, 948696, 925898, 927228, 901690, 915002, 1026430, 1002420, 1001640, 963374, 941246, 934622, 912266, 908110, 897133, 888222, 904247, 895143, 927514, 950343, 955772, 902247, 852307, 840427, 829252, 825586, 872020, 878321, 909708, 929138, 913717, 934331, 866361, 920955, 956465, 915563, 839605, 863942, 908614, 872267, 839624, 869735, 859917, 846941, 849814, 846753, 845031, 818723, 860925, 909895, 839265, 842639, 911157, 951796, 918224, 946340, 936991, 898126, 908973, 879803, 905004, 1008090, 969296, 963146, 946596, 922247, 976966, 978143, 963904, 945931, 855885, 904141, 901654, 871563, 925880, 889975, 898106, 926218, 970291, 938900, 919611, 922643, 973824, 937449, 961554, 988916, 933854, 960353, 920243, 905334, 797496, 778382, 853683, 928090, 937100, 970100, 911518, 946678, 908752, 858591, 875302, 920186, 919124, 908938, 892417, 935890, 920268, 897405, 888311, 927115, 960596, 956573, 968798, 981619, 955169, 926409, 869595, 915905, 895117, 902699, 908021, 937056, 890629, 891579, 946923, 979101, 1043350, 1080580, 1032580, 987129, 940344, 957479, 857260, 811574, 823916, 918877, 904759, 940234, 934990, 858545, 865982, 870586, 842570, 870905, 899840, 945343, 941619, 919907, 950626, 993907, 988865, 965105, 969926, 913606, 1008790, 971637, 931359, 918420, 945220, 984680, 970399, 969755, 967593, 933733, 879108, 839881, 809018, 846883, 859998, 860261, 913135, 882041, 906959, 876661, 826260, 890542, 942534, 909741, 927066, 953612, 955488, 980277, 949661, 953504, 946192, 932916, 885651, 899865, 898701, 871824, 851886, 832122, 960016, 860400, 888914, 959841, 950262, 941942, 859228, 873008, 880301, 949098, 897485, 851622, 940226, 896135, 820358, 853834, 862056, 876981, 878254, 915446, 955044, 916888, 906227, 861205, 884760, 897495, 931712, 866475, 908266, 924603, 855675, 879281, 895025, 1005980, 971694, 891294, 906675, 920438, 873056, 881551, 868115, 829313, 788781, 857344, 925043, 854634, 907179, 880730, 903889, 821904, 783455, 844515, 884679, 879127, 906182, 859311, 868060, 899449, 838987, 846112, 886167, 893178, 932110, 989338, 836770, 878566, 869615, 938533, 963667, 865366, 816790, 832004, 873310, 849541, 800513, 837000, 819206, 853648, 823403, 850925, 908788, 880038, 946504, 877000, 842543, 794959, 793970, 822283, 813697, 838053, 832231, 873679, 832501, 872851, 812361, 818362, 890049, 871964, 868678, 887244, 854394, 888403, 836269, 902430, 913014, 897965, 961720, 953975, 917853, 972456, 1005850, 991200, 911881, 933821, 845094, 961078, 948966, 913942, 953430, 922675, 872991, 838097, 825170, 851685, 830371, 876411, 885263, 846362, 935528, 880902, 888078, 883999, 944167, 967476, 944149, 910935, 910361, 897782, 954991, 950406, 904978, 893067, 933936, 936272, 949470, 906094, 829740, 865663, 890756, 965937, 877660, 921203, 856523, 930813, 887434, 901252, 853524, 919322, 904010, 862904, 919029, 941623, 928009, 968267, 944110, 938383, 926054, 931367, 948907, 906881, 885371, 926675, 988746, 1059210, 1093010, 909839, 962544, 907987, 877685, 877839, 856308, 925522, 991068, 894196, 962554, 853957, 876239, 919339, 888872, 882001, 877350, 897439, 901760, 937169, 951349, 942885, 926563, 918890, 937770, 953081, 909919, 886909, 921034, 931069, 911729, 943106, 910338, 852628, 929128, 907720, 953072, 875960, 885417, 915942, 932722, 928187, 942838, 938319, 932553, 865502, 880473, 965841, 1033720, 989924, 1002870, 1024260, 953925, 940894, 924843, 957526, 917533, 893153, 860289, 851943, 812486, 887610, 944134, 790690, 803566, 803506, 804025, 828927, 855190, 894581, 909986, 912407, 899753, 954901, 937206, 899638, 847824, 898617, 918406, 926988, 874506, 804374, 872765, 830727, 789038, 792480, 840972, 797408, 779561, 895760, 934039, 915241, 927089, 938454, 915421, 926061, 898128, 846730, 797015, 877368, 881406, 925850, 901397, 878360, 865120, 795396, 868239, 876791, 842819, 894838, 889872, 888970, 855117, 888014, 912740, 917521, 868226, 884036, 867019, 847709, 877925, 798256, 720735, 743163, 765515, 783194, 819688, 821702, 838014, 788334, 860009, 803474, 826071, 904210, 882477, 878427, 904622, 873516, 872181, 889932, 862185, 868644, 901731, 902508, 896625, 989853, 929242, 975158, 940076, 931859, 882954, 951493, 969490, 941111, 888128, 863111, 827562, 806434, 754786, 868150, 856922, 846435, 912891, 898169, 847646, 862293, 875162, 898489, 896099, 945113, 985919, 1003560, 1016240, 918401, 958330, 911177, 918296, 869845, 834180, 857415, 844748, 823374, 873549, 868652, 912041, 876600, 970569, 871877, 893658, 928814, 943996, 973672, 919426, 933915, 887829, 928648, 960580, 873132, 854623, 830495, 909116, 862354, 883670, 909540, 901865, 854025, 847010, 915305, 931858, 963088, 867065, 868280, 955958, 854061, 932480, 891537, 964059, 913197, 950986, 899037, 922911, 860142, 798528, 886962, 918071, 902069, 909867, 921985, 805229), `1987` = c(1091550, 1106870, 1112890, 1093790, 1035630, 1058000, 1099650, 1098080, 1125480, 1125670, 1094010, 1113310, 1070190, 1077580, 1122500, 1163880, 1088640, 1142480, 1121410, 1041690, 1149970, 1089150, 1132010, 1176980, 1153820, 1148790, 1149010, 1077790, 1028610, 1048570, 1089970, 1080050, 1073830, 1063670, 1014400, 1042470, 1078240, 1124230, 1107690, 1116270, 1153090, 1129180, 1123460, 1078820, 1042150, 1107880, 998957, 1052620, 1045120, 1098190, 1131900, 1143010, 1137620, 1084080, 1112500, 1064240, 1124260, 1203290, 1204400, 1168250, 1152420, 1170990, 1123230, 1125380, 1055870, 1051430, 1115550, 1134350, 1156160, 1058190, 1019330, 1047900, 1033460, 1090760, 1153930, 1134410, 1047950, 1021560, 1019040, 1096910, 1081070, 1075210, 1040060, 1039710, 1053420, 1086750, 1197530, 1135320, 1051250, 1097520, 1123290, 1173800, 1161640, 1050970, 1100800, 1099480, 1134800, 1145790, 1113610, 1131740, 1098680, 1093220, 1065560, 1089310, 1108700, 1054660, 1033890, 1045770, 1037890, 1102940, 1056330, 1029370, 991981, 988624, 1045450, 1052660, 1021570, 1083640, 1147340, 1132620, 1080310, 1107560, 1060800, 1112610, 1091650, 1093690, 1070620, 1076330, 1151120, 1178350, 1183850, 1131600, 1106570, 1079610, 1093210, 1058220, 1086000, 1076030, 1053830, 1072770, 1034280, 1010760, 1011880, 1014160, 1059230, 1083720, 1124460, 1078840, 1140690, 1157680, 1125670, 1073910, 1087980, 1097220, 1076550, 1063600, 1013290, 1015820, 1112550, 1064670, 1014510, 1060550, 1069010, 1084740, 1058650, 1105630, 1104910, 1112900, 1110000, 1145810, 1120170, 1152300, 1181380, 1149410, 1114900, 1158020, 1087060, 1090420, 1069220, 1078480, 1153350, 1163110, 1130080, 1127900, 1058780, 1099540, 1067320, 1126840, 1101490, 1138610, 1141920, 1102810, 1117490, 1071290, 1088120, 1116180, 1089320, 1091540, 1096180, 1065450, 1070960, 1035270, 1060650, 1062890, 1135580, 1130130, 1116980, 1106940, 1058080, 1077230, 1118820, 975615, 1072330, 1081950, 1069800, 1112630, 1114500, 1080010, 1111070, 1162920, 1158290, 1187840, 1132550, 1139040, 1141540, 1128870, 1124180, 1138850, 1101130, 1164600, 1146190, 1100600, 1131820, 1089820, 1137830, 1104600, 1108600, 1118380, 1090990, 1093170, 1070010, 1075120, 1108630, 1103560, 1087490, 1159870, 1053090, 1090350, 1011920, 1077370, 1069790, 1076280, 1074000, 1045640, 1097340, 1023090, 1055710, 1076410, 1070550, 1012480, 1027830, 1083860, 1121220, 1107740, 1110110, 1122420, 1101650, 1088050, 1096920, 1138230, 1145430, 1050090, 1138140, 1077310, 1098190, 1115630, 1161190, 1189510, 1154600, 1151030, 1156390, 1088670, 1149980, 1172500, 1159420, 1120560, 1116840, 1084040, 1035180, 1072240, 1081120, 1115240, 1070110, 1142930, 1165360, 1171610, 1175690, 1068910, 1035560, 1052360, 1076480, 1147640, 1133640, 1136330, 1108550, 1096110, 1047480, 1112240, 1122670, 1092220, 1068340, 1040570, 982460, 1071980, 1114410, 1093690, 1080970, 1021430, 963665, 986795, 998233, 1031800, 1122070, 1086720, 1050290, 1101870, 1085380, 1128850, 1081140, 1011650, 1045230, 1112820, 1056960, 1100790, 1103180, 1156600, 1154690, 1149160, 1118390, 1071090, 1067830, 1091880, 1113610, 1167270, 1175040, 1147450, 1190970, 1154660, 1174460, 1214030, 1163380, 1112530, 1116330, 1143400, 1129340, 1093030, 1135410, 1101160, 1103990, 1129320, 1132410, 1158630, 1142600, 1140800, 1166640, 1102690, 1098690, 1072540, 1090750, 1077640, 1077360, 1116310, 1102140, 1068390, 1089810, 1064220, 1106850, 1091900, 1131510, 1154190, 1077260, 1141760, 1113720, 1067000, 1120700, 1093550, 1097440, 1132200, 1090380, 1090340, 1058260, 1055710, 1030120, 1050400, 1067890, 1066130, 1106580, 1087250, 1045640, 1062320, 1091590, 1042630, 1053930, 1129300, 1185530, 1120640, 1111630, 1140820, 1115540, 1113170, 1111790, 1196200, 1148420, 1145650, 1122390, 1135770, 1070880, 1083550, 1070330, 1080720, 1058860, 1038350, 1068430, 1093550, 1078690, 1080600, 1076730, 1049330, 1045110, 1040420, 1047730, 1047800, 1055660, 1079070, 1070350, 1064710, 1108970, 1079860, 1152890, 1159790, 1132950, 1066160, 1041200, 1069300, 1047330, 1022170, 1042000, 1045520, 1024260, 1019270, 1029200, 1040050, 1027090, 1079630, 1129770, 1061700, 1078550, 1172830, 1164580, 1111620, 1150260, 1110130, 1093600, 1117290, 1111910, 1119170, 1205570, 1189900, 1186640, 1156670, 1117160, 1182890, 1208680, 1201970, 1160050, 1099850, 1119140, 1131510, 1166460, 1176960, 1136510, 1131730, 1145210, 1157210, 1125770, 1133280, 1139950, 1174970, 1115890, 1132790, 1143690, 1076020, 1099400, 1060610, 1068960, 1016380, 1019960, 1070370, 1113240, 1073330, 1079120, 1051170, 1071220, 1084550, 1056650, 1090280, 1138480, 1128290, 1105310, 1023690, 1070060, 1038510, 1041140, 1042060, 1111560, 1106810, 1086890, 1104670, 1140120, 1113650, 1101620, 1057840, 1063700, 1089060, 1091100, 1107210, 1088450, 1062720, 1077290, 1109650, 1172600, 1208660, 1252790, 1218030, 1174450, 1128030, 1138110, 1116750, 1102550, 1104650, 1144080, 1115760, 1121780, 1124170, 1061510, 1051500, 1057670, 1019910, 1043540, 1072570, 1080050, 1040860, 1019970, 1052170, 1072140, 1101050, 1118240, 1109520, 1080870, 1127150, 1157030, 1121640, 1083480, 1142030, 1146410, 1168950, 1150700, 1138230, 1145890, 1043290, 1001850, 956919, 974005, 1006610, 1028500, 1077710, 1055200, 1065120, 1083120, 1027000, 1116600, 1153450, 1123110, 1113180, 1099740, 1088930, 1097580, 1055840, 1070110, 1093470, 1046070, 1002990, 1023390, 1003610, 1038430, 1020830, 1061950, 1114610, 1053580, 1083430, 1151720, 1105720, 1103430, 1031180, 1046170, 1052560, 1115050, 1068690, 998579, 1033740, 1078570, 1014440, 1044460, 1050660, 1087070, 1103850, 1115650, 1117230, 1083100, 1093390, 1074910, 1094520, 1065370, 1114340, 1062000, 1098180, 1097990, 1084140, 1099710, 1138430, 1146730, 1116710, 1048150, 1029630, 1044670, 1041760, 1026580, 1063040, 1021290, 986777, 1037220, 1089640, 1049590, 1075050, 1025710, 1067380, 1054180, 980567, 1043940, 1060120, 1037760, 1067150, 1015340, 1091660, 1147590, 1078370, 1105640, 1126570, 1092450, 1137470, 1115970, 1047660, 1123500, 1104190, 1126920, 1176270, 1093100, 1016760, 994042, 1030780, 1031900, 1019450, 1054370, 1053040, 1071150, 1028460, 1049640, 1083700, 1045340, 1072730, 1070650, 1044000, 1042250, 991098, 1030640, 1059840, 1080470, 1048170, 1078760, 1040900, 1051940, 1024010, 1037360, 1103450, 1075240, 1039750, 1074290, 1041300, 1064240, 1039460, 1111850, 1096840, 1066000, 1070580, 1063660, 1106200, 1137490, 1180290, 1134410, 1085840, 1079470, 1073310, 1167030, 1129160, 1089460, 1110770, 1087640, 1054620, 1012540, 1024320, 1033270, 1001890, 1076330, 1114370, 1064890, 1106740, 1105400, 1103850, 1098360, 1091670, 1110730, 1091430, 1047810, 1067430, 1077070, 1132930, 1134980, 1112270, 1096460, 1145780, 1173640, 1234350, 1173760, 1169730, 1120650, 1124070, 1169970, 1108200, 1084180, 1096930, 1160360, 1134510, 1124870, 1101380, 1168050, 1196320, 1155550, 1166900, 1156110, 1141410, 1130110, 1112370, 1081820, 1080020, 1056560, 1094800, 1075810, 1089720, 1059870, 1124960, 1185190, 1200630, 1033920, 1118730, 1098200, 1071060, 1068170, 1044920, 1121040, 1156150, 1088400, 1132260, 1037320, 1071000, 1098730, 1120040, 1115730, 1113980, 1184780, 1130640, 1141920, 1160210, 1162760, 1126120, 1136480, 1105240, 1180550, 1135690, 1115900, 1120060, 1148350, 1112250, 1160740, 1146430, 1122100, 1151970, 1197930, 1135910, 1110250, 1127690, 1087170, 1091750, 1115350, 1125780, 1093530, 1074860, 1011100, 1038570, 1111340, 1188820, 1154230, 1119980, 1121160, 1115490, 1102790, 1102400, 1161160, 1123110, 1088890, 1065800, 1038100, 1024730, 1115940, 1114450, 1059330, 1017770, 1035220, 1064080, 1050610, 1082780, 1077540, 1081860, 1044550, 1065440, 1068350, 1116620, 1059730, 1045750, 1099140, 1097170, 1114150, 1065340, 1058060, 1096370, 1087910, 1017610, 1011600, 1048260, 1083790, 1054230, 1112980, 1117600, 1120130, 1111110, 1109210, 1075270, 1076170, 1090970, 1036180, 1002640, 1053060, 1083840, 1137580, 1071690, 1039340, 1076990, 1050050, 1077940, 1115630, 1126800, 1126020, 1084970, 1140880, 1103470, 1092900, 1103030, 1098800, 1070630, 1072970, 1061950, 1077320, 1095680, 1042970, 1007020, 1010730, 1039430, 1044430, 1091720, 1092950, 1100790, 1097110, 1095510, 1069410, 1069050, 1120300, 1095480, 1107890, 1111290, 1098540, 1107010, 1105310, 1066090, 1059060, 1106450, 1091550, 1082620, 1130610, 1079220, 1135710, 1092240, 1082050, 1098760, 1144400, 1131240, 1139800, 1103690, 1081750, 1034080, 1054370, 1073720, 1130700, 1107000, 1067160, 1129040, 1114870, 1063500, 1057510, 1057710, 1084580, 1068630, 1085770, 1119810, 1145070, 1168100, 1055780, 1118330, 1094140, 1115170, 1039210, 993108, 1021860, 1062640, 1055230, 1080670, 1059380, 1097540, 1105900, 1164220, 1079570, 1137420, 1103950, 1142130, 1098850, 1061660, 1094210, 1043110, 1044910, 1069890, 999601, 1031310, 1019120, 1079130, 1025940, 1016460, 1066410, 1077090, 1016500, 1042840, 1122730, 1123720, 1149370, 1088330, 1037690, 1125200, 1037170, 1072870, 1052930, 1111610, 1079710, 1108400, 1078480, 1121100, 1075320, 1032300, 1084160, 1117240, 1088330, 1130870, 1163800, 1077550), `1988` = c(1193100, 1244460, 1256120, 1206470, 1183280, 1201340, 1252190, 1202790, 1200930, 1234420, 1275570, 1261130, 1232510, 1227910, 1207350, 1243090, 1171540, 1213380, 1200430, 1141620, 1208550, 1186180, 1182270, 1244440, 1263480, 1257410, 1235240, 1173420, 1169730, 1143260, 1176410, 1162200, 1201340, 1228530, 1164040, 1195190, 1206530, 1208510, 1179290, 1168230, 1196910, 1230620, 1188350, 1180830, 1124140, 1157120, 1117610, 1169070, 1165300, 1176340, 1178780, 1149790, 1177670, 1159290, 1205970, 1186640, 1263850, 1259960, 1287450, 1218260, 1216640, 1229760, 1213540, 1195050, 1203590, 1202810, 1250420, 1221840, 1202750, 1092420, 1062030, 1139230, 1104060, 1151090, 1206530, 1210750, 1192050, 1158460, 1142440, 1191900, 1226870, 1211110, 1182130, 1173760, 1203420, 1211520, 1290180, 1216460, 1146220, 1178170, 1189370, 1244100, 1203700, 1160670, 1203750, 1198870, 1232430, 1247000, 1213380, 1224850, 1200170, 1188240, 1220960, 1245060, 1245670, 1212980, 1175260, 1183770, 1185250, 1184770, 1154200, 1151720, 1184970, 1172440, 1215560, 1194680, 1120080, 1196740, 1217630, 1211300, 1185110, 1216680, 1202990, 1204890, 1207530, 1226970, 1197460, 1212450, 1282990, 1273360, 1279680, 1234060, 1226010, 1211900, 1263470, 1221600, 1244720, 1235880, 1199730, 1203190, 1172050, 1182080, 1176670, 1198640, 1192600, 1204100, 1226870, 1177710, 1228760, 1232990, 1226170, 1170070, 1209350, 1174670, 1165720, 1156310, 1097640, 1133480, 1190060, 1172150, 1154880, 1168620, 1208020, 1239750, 1223860, 1226870, 1229950, 1210780, 1188380, 1234210, 1210690, 1180590, 1189520, 1183680, 1166600, 1218520, 1166480, 1220940, 1207460, 1191160, 1209110, 1239460, 1208150, 1212380, 1196030, 1208420, 1213660, 1211810, 1201030, 1237260, 1243240, 1199650, 1185550, 1177000, 1151450, 1160770, 1168810, 1184920, 1183180, 1205040, 1226230, 1171660, 1219980, 1178050, 1198310, 1195970, 1170890, 1186540, 1182980, 1178830, 1187440, 1078820, 1135700, 1159310, 1182680, 1210370, 1199930, 1216420, 1210020, 1209800, 1218980, 1223740, 1170680, 1207610, 1222850, 1213630, 1215450, 1271570, 1272630, 1306400, 1273320, 1249270, 1236050, 1188920, 1214380, 1227600, 1241370, 1209830, 1200680, 1233110, 1192860, 1150680, 1211000, 1189200, 1185140, 1228950, 1110570, 1139890, 1122440, 1169370, 1174400, 1145170, 1126520, 1134310, 1152540, 1089110, 1151820, 1180460, 1146770, 1113080, 1142410, 1163500, 1193150, 1169740, 1207420, 1183870, 1169600, 1209380, 1224080, 1196030, 1193600, 1090830, 1186210, 1145440, 1191410, 1195170, 1197180, 1221940, 1230000, 1251300, 1216520, 1217710, 1257030, 1258680, 1238900, 1227940, 1205600, 1153200, 1104980, 1142090, 1163680, 1218950, 1184240, 1245860, 1269410, 1254340, 1255300, 1187410, 1215790, 1180850, 1192740, 1231320, 1182430, 1219520, 1210090, 1187350, 1145140, 1197130, 1200220, 1186370, 1165250, 1188990, 1123100, 1207640, 1211130, 1207430, 1219200, 1146530, 1099490, 1130580, 1124450, 1159010, 1197970, 1167350, 1160000, 1161120, 1126870, 1157820, 1108220, 1083140, 1110280, 1178460, 1165060, 1196120, 1176730, 1164880, 1175160, 1204400, 1155340, 1126920, 1123100, 1181620, 1209930, 1240640, 1265910, 1226710, 1265220, 1216270, 1196030, 1248240, 1233900, 1219210, 1223260, 1247450, 1264220, 1212410, 1228120, 1211860, 1200920, 1245820, 1254050, 1278060, 1253630, 1262780, 1249220, 1238950, 1226850, 1219920, 1248590, 1202920, 1184550, 1210320, 1192920, 1200370, 1230200, 1191420, 1205480, 1196250, 1239050, 1218130, 1157360, 1205360, 1176970, 1147980, 1205890, 1152760, 1181710, 1184530, 1196850, 1218790, 1162510, 1173200, 1141470, 1173740, 1180310, 1187510, 1226830, 1220370, 1176480, 1193660, 1191060, 1170010, 1174100, 1243340, 1273550, 1257580, 1249850, 1286380, 1255760, 1233290, 1236440, 1292850, 1260910, 1241800, 1233700, 1238340, 1166570, 1201500, 1217160, 1219390, 1199300, 1166610, 1161230, 1188430, 1210740, 1219050, 1170550, 1166660, 1173080, 1168610, 1181990, 1164420, 1187620, 1227630, 1289790, 1263490, 1239130, 1214660, 1252230, 1256820, 1249970, 1205600, 1191710, 1224670, 1185810, 1154540, 1207000, 1207790, 1214250, 1215080, 1183860, 1209430, 1173860, 1221830, 1241580, 1198640, 1215270, 1304340, 1267340, 1222830, 1279090, 1230540, 1227660, 1249270, 1212600, 1192980, 1255510, 1282910, 1279500, 1286480, 1223250, 1240950, 1295170, 1292160, 1296190, 1259510, 1269760, 1231110, 1245410, 1254370, 1217670, 1204620, 1221080, 1225820, 1202410, 1192380, 1184290, 1224430, 1191620, 1237000, 1270660, 1227940, 1221750, 1199330, 1206250, 1188390, 1163710, 1173850, 1175120, 1163090, 1177990, 1181470, 1205420, 1254420, 1223290, 1238240, 1256910, 1249300, 1214160, 1134000, 1149560, 1166770, 1202680, 1164860, 1213770, 1178250, 1196110, 1201420, 1187960, 1181070, 1198250, 1169750, 1178790, 1206220, 1210540, 1208540, 1193740, 1198680, 1211690, 1259160, 1288560, 1293270, 1266980, 1248910, 1210420, 1212520, 1158860, 1155770, 1201690, 1205510, 1250520, 1227100, 1205810, 1186670, 1154570, 1119610, 1095850, 1094230, 1124100, 1152700, 1139330, 1074030, 1077630, 1096630, 1103370, 1136580, 1159260, 1180610, 1156560, 1187790, 1214130, 1175900, 1172930, 1225250, 1222940, 1236910, 1265520, 1262920, 1243450, 1182400, 1167580, 1161810, 1136990, 1158200, 1174740, 1177400, 1137270, 1183120, 1186320, 1143400, 1270080, 1244110, 1179530, 1197110, 1212860, 1194780, 1184710, 1164030, 1194900, 1183560, 1172900, 1162310, 1164260, 1153190, 1158950, 1156170, 1188250, 1208910, 1189680, 1204610, 1242400, 1221930, 1190620, 1163700, 1174880, 1217370, 1232800, 1164010, 1179600, 1180940, 1197670, 1148880, 1161590, 1158140, 1197050, 1188950, 1202070, 1199090, 1171810, 1181700, 1190540, 1222620, 1173130, 1215030, 1181270, 1223790, 1229830, 1183880, 1228400, 1228270, 1211050, 1188090, 1169300, 1175120, 1206340, 1232800, 1188910, 1201050, 1170630, 1128490, 1191010, 1173140, 1146700, 1183450, 1163600, 1199300, 1169430, 1133450, 1255480, 1199330, 1218940, 1242850, 1164990, 1185290, 1242680, 1200740, 1187120, 1196600, 1164730, 1221310, 1178710, 1182540, 1185490, 1151890, 1174580, 1230320, 1157280, 1124310, 1131630, 1165070, 1154380, 1150650, 1152380, 1152090, 1176790, 1128770, 1152510, 1187340, 1154790, 1209140, 1217140, 1187350, 1192470, 1202440, 1219960, 1196440, 1227410, 1217400, 1219450, 1138980, 1164030, 1115630, 1124400, 1193900, 1137180, 1155500, 1159050, 1155660, 1199730, 1207360, 1257090, 1215290, 1238090, 1245540, 1197940, 1258340, 1209690, 1206960, 1190740, 1221470, 1199930, 1218750, 1259750, 1236200, 1206370, 1234350, 1235560, 1185810, 1191700, 1176820, 1186130, 1106780, 1150600, 1166290, 1163670, 1187260, 1183830, 1205100, 1191870, 1198930, 1203490, 1197120, 1131320, 1179560, 1146340, 1155120, 1173720, 1166920, 1157750, 1174590, 1182460, 1241310, 1201670, 1226840, 1190220, 1171920, 1224110, 1181840, 1192750, 1168600, 1161650, 1177840, 1181640, 1191700, 1229790, 1274190, 1291350, 1267840, 1203670, 1232560, 1254920, 1233310, 1204070, 1209740, 1170630, 1216580, 1210490, 1225220, 1219410, 1265680, 1271350, 1301460, 1200060, 1231230, 1176370, 1147240, 1159710, 1155050, 1192490, 1241180, 1194200, 1258180, 1173650, 1178600, 1161470, 1175970, 1189820, 1212800, 1276830, 1237000, 1249250, 1271020, 1224400, 1230990, 1227900, 1213690, 1288350, 1273720, 1236080, 1233340, 1244220, 1176910, 1223150, 1213790, 1175650, 1203720, 1234860, 1240180, 1220640, 1260250, 1224240, 1237530, 1214750, 1236670, 1218900, 1200990, 1147150, 1169510, 1186130, 1245860, 1220830, 1136430, 1170730, 1216720, 1240560, 1273260, 1324750, 1269680, 1248090, 1212940, 1207760, 1189750, 1223150, 1220600, 1186690, 1149720, 1170630, 1198310, 1206440, 1186150, 1178570, 1177000, 1158070, 1183420, 1173110, 1228110, 1193310, 1175420, 1220780, 1219950, 1222760, 1189270, 1176300, 1185220, 1176330, 1119130, 1142030, 1189650, 1206080, 1166910, 1200150, 1207880, 1183830, 1186390, 1185050, 1147380, 1170110, 1198490, 1160680, 1110010, 1117230, 1167140, 1224480, 1177550, 1154970, 1186700, 1161910, 1235570, 1168730, 1173870, 1193910, 1164080, 1190000, 1182600, 1176490, 1178710, 1195500, 1184540, 1149410, 1167430, 1190700, 1183800, 1175780, 1168760, 1175960, 1168740, 1188270, 1217300, 1203160, 1188850, 1173900, 1182990, 1172670, 1167340, 1184980, 1121790, 1215410, 1216170, 1196800, 1180480, 1174150, 1190090, 1163430, 1217270, 1167460, 1172630, 1245520, 1177900, 1227270, 1198460, 1207090, 1182120, 1200930, 1223970, 1198470, 1168500, 1184470, 1169820, 1184940, 1184110, 1237450, 1181280, 1152880, 1192740, 1201820, 1143790, 1189670, 1181560, 1174750, 1220970, 1276680, 1242120, 1257720, 1268200, 1135910, 1214000, 1196010, 1178530, 1175200, 1132060, 1131610, 1180390, 1162650, 1204970, 1184170, 1211030, 1200080, 1254290, 1219950, 1261780, 1215690, 1244310, 1216660, 1221670, 1218790, 1178230, 1172590, 1174030, 1134290, 1173530, 1156090, 1220410, 1172690, 1156340, 1168640, 1197960, 1165300, 1184650, 1200750, 1196450, 1204660, 1175710, 1146180, 1198290, 1128230, 1142900, 1157480, 1194820, 1176470, 1213150, 1192380, 1213110, 1181860, 1143700, 1169380, 1228850, 1191700, 1204550, 1220050, 1137140), `1989` = c(1196150, 1286040, 1281330, 1220510, 1199730, 1221110, 1263880, 1212790, 1187890, 1222410, 1234790, 1222330, 1220550, 1222030, 1215870, 1244920, 1227120, 1239870, 1183080, 1143920, 1238290, 1197640, 1171770, 1194950, 1213750, 1199770, 1196670, 1158040, 1195720, 1184920, 1212460, 1189830, 1203840, 1193830, 1161450, 1193780, 1193270, 1186030, 1152630, 1145180, 1177220, 1256470, 1217380, 1190810, 1166620, 1167900, 1145130, 1175150, 1210840, 1218040, 1239060, 1219440, 1225650, 1198450, 1236240, 1201260, 1250880, 1243480, 1271180, 1202030, 1210670, 1221590, 1204810, 1182200, 1181510, 1195440, 1186910, 1189040, 1184550, 1079630, 1070660, 1130510, 1105690, 1162090, 1239880, 1235350, 1226880, 1210140, 1164410, 1209100, 1261420, 1257540, 1243140, 1202790, 1232760, 1216990, 1298190, 1234010, 1170420, 1172530, 1173140, 1219270, 1192850, 1121570, 1172710, 1198570, 1237570, 1209760, 1194230, 1199320, 1196110, 1164730, 1191510, 1223050, 1220090, 1171830, 1177420, 1209640, 1222320, 1195680, 1186190, 1201790, 1230310, 1196060, 1203660, 1223390, 1168190, 1212680, 1228110, 1224180, 1180020, 1202780, 1197380, 1200630, 1207450, 1232690, 1224790, 1227480, 1286550, 1306720, 1269880, 1234950, 1211960, 1185180, 1234650, 1171810, 1181940, 1191130, 1171260, 1177720, 1155340, 1191830, 1184530, 1205640, 1231500, 1255460, 1257840, 1201270, 1213860, 1229860, 1230360, 1180820, 1203130, 1214850, 1141320, 1155830, 1110460, 1127230, 1197360, 1173480, 1155240, 1175730, 1203490, 1242320, 1229110, 1221320, 1224570, 1183190, 1164860, 1187300, 1176600, 1159410, 1180620, 1192130, 1159620, 1207220, 1144030, 1178070, 1174450, 1173260, 1216330, 1229840, 1208270, 1224860, 1222340, 1199770, 1215210, 1217370, 1178210, 1218990, 1217460, 1185290, 1198980, 1172370, 1190960, 1168430, 1181470, 1207790, 1217190, 1248910, 1255320, 1189630, 1236640, 1184890, 1191550, 1183120, 1161410, 1199860, 1189940, 1191580, 1222960, 1133750, 1181900, 1207230, 1223310, 1242870, 1221660, 1247750, 1210260, 1212840, 1204670, 1187250, 1162840, 1204220, 1217600, 1194630, 1185560, 1252240, 1251180, 1292850, 1267470, 1227560, 1221820, 1177370, 1207350, 1213250, 1249440, 1218930, 1217250, 1253420, 1211010, 1173890, 1211230, 1183790, 1189770, 1234930, 1167130, 1196120, 1171920, 1193490, 1220920, 1163920, 1149810, 1136400, 1183030, 1115790, 1158180, 1165270, 1162820, 1121320, 1154070, 1145190, 1153040, 1154690, 1188860, 1142730, 1132200, 1190280, 1194290, 1172640, 1188250, 1111630, 1180270, 1146300, 1176810, 1216270, 1180220, 1230160, 1237720, 1264320, 1249940, 1250500, 1285410, 1273160, 1247970, 1250480, 1223240, 1209520, 1157360, 1187600, 1184680, 1240090, 1185540, 1226820, 1207950, 1207110, 1217230, 1163570, 1226670, 1192190, 1202570, 1225820, 1184450, 1202300, 1222900, 1183990, 1160750, 1204680, 1192650, 1194150, 1162650, 1197370, 1126800, 1209260, 1199290, 1190590, 1217360, 1169260, 1145570, 1152870, 1130080, 1204740, 1224930, 1208440, 1191470, 1192790, 1156650, 1156230, 1116670, 1109520, 1132400, 1194310, 1166810, 1198100, 1190720, 1184180, 1177690, 1221710, 1199470, 1192030, 1135550, 1149360, 1183980, 1212350, 1226180, 1204290, 1230000, 1198490, 1179500, 1228890, 1230580, 1208740, 1220040, 1248190, 1229070, 1211210, 1209690, 1209890, 1231500, 1286900, 1292610, 1289510, 1267480, 1259270, 1200570, 1194970, 1205250, 1187120, 1223260, 1187740, 1182450, 1179380, 1173010, 1191510, 1206410, 1171980, 1179220, 1187840, 1229090, 1190340, 1190120, 1233080, 1218730, 1195230, 1223890, 1218010, 1192170, 1180100, 1203740, 1222330, 1181350, 1226670, 1186600, 1236540, 1230540, 1216380, 1238110, 1212080, 1161410, 1198520, 1205280, 1183380, 1177840, 1270510, 1256400, 1260740, 1246650, 1299780, 1265930, 1232580, 1230530, 1263980, 1238410, 1246230, 1254660, 1259670, 1191750, 1207110, 1215150, 1198440, 1199850, 1149500, 1156640, 1152340, 1205010, 1195160, 1157150, 1166440, 1162440, 1143280, 1167580, 1175490, 1217660, 1204260, 1262530, 1244850, 1198570, 1191570, 1234460, 1219500, 1220610, 1211430, 1205800, 1242250, 1209200, 1164210, 1235360, 1197450, 1199370, 1177890, 1142170, 1191010, 1142260, 1168980, 1199640, 1151640, 1157920, 1254430, 1225120, 1176450, 1245160, 1247800, 1244690, 1273420, 1220890, 1184820, 1242820, 1288500, 1258770, 1256750, 1228350, 1226090, 1293090, 1308600, 1312650, 1301190, 1282860, 1243880, 1255260, 1258240, 1203470, 1201070, 1234130, 1223920, 1199680, 1159430, 1164760, 1223740, 1175900, 1192150, 1253960, 1224240, 1207670, 1202560, 1199430, 1198310, 1198740, 1208820, 1191080, 1203800, 1196360, 1186500, 1220710, 1232110, 1205680, 1226240, 1227060, 1235430, 1217160, 1168890, 1180660, 1181850, 1187940, 1149650, 1204010, 1158400, 1188880, 1217830, 1216040, 1181860, 1217600, 1166470, 1175600, 1216650, 1231150, 1235890, 1216390, 1210920, 1211760, 1241040, 1247520, 1232720, 1245040, 1248820, 1219880, 1198430, 1181430, 1191860, 1194540, 1199250, 1257000, 1206610, 1178690, 1192800, 1170390, 1144870, 1094180, 1091050, 1123880, 1136500, 1150900, 1130010, 1108020, 1101450, 1118330, 1157140, 1175210, 1181580, 1142480, 1186450, 1191800, 1174300, 1170330, 1228090, 1198820, 1225220, 1242070, 1251600, 1249030, 1199280, 1154470, 1137470, 1107740, 1136170, 1175350, 1169870, 1122200, 1174490, 1180210, 1133870, 1262120, 1239030, 1182070, 1199460, 1205920, 1186450, 1180450, 1170950, 1209260, 1187890, 1144970, 1165200, 1142080, 1142190, 1162280, 1161080, 1206400, 1196410, 1191480, 1204120, 1262870, 1242410, 1227960, 1196690, 1209310, 1216990, 1221550, 1155390, 1163750, 1172340, 1197630, 1180410, 1196710, 1172300, 1221960, 1197940, 1199210, 1208480, 1174750, 1170840, 1174090, 1187680, 1161190, 1196330, 1179430, 1185000, 1216960, 1181060, 1236990, 1236740, 1217580, 1162700, 1150480, 1171880, 1192850, 1247780, 1187980, 1211830, 1189140, 1180820, 1220850, 1194760, 1176240, 1216190, 1170510, 1207390, 1171680, 1134860, 1240260, 1161210, 1186350, 1193100, 1129990, 1153690, 1203460, 1137150, 1115380, 1167010, 1146100, 1182280, 1141630, 1170340, 1200980, 1190120, 1200250, 1245060, 1160930, 1133840, 1136810, 1157000, 1172980, 1161310, 1158480, 1156990, 1182130, 1148070, 1169800, 1201120, 1163010, 1219110, 1207680, 1194880, 1185350, 1211670, 1224790, 1203500, 1230780, 1224380, 1230500, 1184510, 1200570, 1174300, 1191780, 1214180, 1178090, 1195050, 1166400, 1166490, 1162940, 1196320, 1245230, 1210670, 1231340, 1239950, 1190350, 1226910, 1185800, 1216930, 1171510, 1220760, 1209340, 1209600, 1237570, 1209020, 1192320, 1227860, 1215210, 1169130, 1196010, 1176960, 1177620, 1127540, 1164410, 1162650, 1156380, 1163410, 1151510, 1162860, 1129200, 1148000, 1204790, 1206540, 1159470, 1221470, 1197950, 1202720, 1211590, 1222170, 1235360, 1234380, 1192930, 1239520, 1188300, 1228310, 1201900, 1180360, 1237710, 1204870, 1213640, 1178750, 1168770, 1161540, 1182420, 1182270, 1202940, 1236020, 1266360, 1238470, 1170770, 1215550, 1214220, 1200660, 1173740, 1206060, 1208120, 1215540, 1190870, 1184780, 1210460, 1241860, 1221310, 1264280, 1172220, 1197550, 1163680, 1134200, 1149880, 1146330, 1233800, 1231670, 1170970, 1258330, 1209070, 1188630, 1212040, 1216290, 1234170, 1266590, 1304960, 1263000, 1251530, 1271380, 1238350, 1233410, 1216000, 1221080, 1272900, 1285970, 1237200, 1229730, 1236110, 1177900, 1244110, 1195390, 1160270, 1187240, 1236040, 1236480, 1221010, 1250890, 1215170, 1201700, 1177350, 1225880, 1200290, 1196500, 1188220, 1193410, 1214330, 1250430, 1221730, 1159380, 1168290, 1245310, 1217420, 1244030, 1279140, 1241450, 1240860, 1206930, 1206080, 1174500, 1198230, 1198870, 1185690, 1139310, 1131020, 1185170, 1225920, 1228990, 1211070, 1211080, 1185360, 1201730, 1175330, 1232180, 1198140, 1187260, 1219520, 1253070, 1209280, 1197820, 1148520, 1156160, 1163010, 1094190, 1107790, 1174160, 1184050, 1115150, 1156790, 1163510, 1168000, 1160600, 1177060, 1152280, 1172990, 1207240, 1189560, 1145710, 1119170, 1158760, 1240390, 1198400, 1179830, 1252000, 1199870, 1231010, 1199400, 1180510, 1204350, 1189290, 1205550, 1200690, 1210730, 1192400, 1179360, 1172320, 1158530, 1194030, 1222700, 1235860, 1214330, 1220740, 1212350, 1185790, 1174220, 1203860, 1196840, 1190430, 1174980, 1173000, 1147240, 1162760, 1190160, 1135080, 1179430, 1182690, 1166910, 1186920, 1172840, 1202240, 1191840, 1246900, 1216040, 1202550, 1259940, 1209220, 1245130, 1257210, 1252470, 1227830, 1200320, 1218130, 1209820, 1210570, 1207190, 1221440, 1210730, 1206650, 1251980, 1199250, 1185750, 1229980, 1228800, 1150550, 1191450, 1177140, 1195000, 1276390, 1287650, 1244450, 1249610, 1237810, 1146750, 1218810, 1209520, 1182570, 1177760, 1188450, 1197350, 1232450, 1211410, 1232520, 1205070, 1221770, 1188200, 1234580, 1228510, 1288500, 1243190, 1255540, 1218800, 1201770, 1216830, 1210910, 1188310, 1163180, 1180100, 1195900, 1167410, 1199130, 1157240, 1141720, 1153280, 1182260, 1146180, 1191400, 1200320, 1193790, 1201370, 1182530, 1183090, 1188490, 1113960, 1146200, 1136520, 1181570, 1179870, 1224160, 1199990, 1220060, 1201780, 1168720, 1197900, 1238810, 1186130, 1179230, 1192800, 1127730), `1990` = c(912646, 997157, 1009020, 929436, 899016, 906843, 967487, 914020, 904932, 932891, 917343, 898729, 919769, 912639, 916582, 952478, 924368, 938204, 885646, 846299, 926972, 891684, 905117, 913226, 930221, 894042, 897131, 834839, 884597, 872649, 903640, 896316, 897332, 886906, 878828, 919190, 917066, 890072, 866887, 848366, 879272, 958664, 920862, 919589, 915206, 887823, 860824, 862465, 900698, 914182, 947617, 932591, 949407, 924408, 953345, 926001, 956440, 972330, 973226, 917094, 923447, 923762, 907837, 889106, 885747, 911046, 928944, 908161, 910260, 813140, 837534, 881510, 847871, 885303, 939795, 957311, 952416, 931664, 896606, 941846, 979534, 959814, 948110, 907548, 950434, 936079, 1014710, 969126, 903705, 885417, 895291, 935506, 917941, 833747, 875896, 908286, 943484, 926098, 906046, 915804, 896103, 890170, 916394, 944384, 949532, 889182, 877932, 911272, 912549, 890205, 877294, 901088, 925305, 893305, 911065, 919768, 863886, 905492, 952317, 950422, 913598, 927500, 917875, 905962, 926962, 938732, 943141, 934833, 972965, 1004180, 969610, 933953, 919540, 897822, 929612, 891991, 887839, 883842, 884690, 900932, 882140, 901498, 874556, 909158, 937401, 942673, 928687, 864455, 889044, 900110, 909231, 877154, 902510, 913990, 829913, 866714, 857817, 871185, 935607, 950007, 915501, 912925, 939377, 967002, 923230, 919453, 917854, 891624, 872879, 891057, 890489, 885650, 910615, 920871, 888489, 914549, 850399, 908053, 900678, 902827, 940585, 959193, 937222, 947790, 931770, 910061, 930077, 952468, 889249, 931791, 929386, 908752, 920913, 892308, 918174, 893352, 907991, 931500, 909595, 940842, 948910, 896215, 944153, 899871, 907361, 914533, 879148, 890506, 887134, 895415, 936799, 842356, 879458, 914805, 941406, 963025, 942788, 976829, 931341, 949304, 925270, 916391, 906481, 946657, 941741, 890454, 917903, 972021, 973286, 996470, 970845, 944032, 955918, 907700, 936822, 943023, 958908, 935239, 929673, 955056, 918673, 886380, 928173, 906165, 902768, 944789, 883134, 924765, 889075, 908703, 929819, 868117, 883078, 869146, 921427, 893508, 904312, 913360, 931532, 894345, 889339, 881519, 883340, 877203, 918452, 863294, 865188, 906200, 908491, 897244, 918783, 864207, 916256, 890669, 902417, 920242, 906053, 938514, 947547, 975738, 983366, 970640, 982445, 984084, 973779, 963466, 925240, 930846, 899768, 912575, 895117, 958382, 898157, 949926, 919340, 909897, 913029, 893652, 940849, 907418, 926686, 932203, 903905, 921433, 943772, 897792, 889777, 907738, 911021, 909932, 873073, 902087, 844793, 929175, 921179, 896967, 922436, 875237, 890238, 899667, 858073, 914521, 935821, 926588, 923063, 924549, 891684, 879480, 850905, 846891, 866421, 901088, 889329, 914181, 914427, 916532, 920747, 943456, 915381, 909091, 858873, 878526, 893058, 913323, 910369, 908366, 924767, 902635, 882307, 927037, 928366, 902490, 921499, 941005, 921051, 899793, 902640, 915858, 925983, 973115, 989333, 991719, 971055, 966147, 904209, 900613, 910729, 889084, 938823, 913398, 932601, 919484, 910637, 913116, 928516, 900825, 896479, 892016, 928716, 899827, 905580, 954719, 944216, 919697, 939483, 936786, 915400, 899768, 934146, 945945, 905389, 929302, 902015, 940133, 942199, 927678, 956704, 911621, 864668, 890366, 903594, 900206, 895344, 979577, 968094, 977775, 970534, 1007170, 956245, 929409, 924088, 967444, 951445, 948737, 968173, 962615, 893222, 898727, 914585, 902571, 914828, 885093, 872008, 886656, 916177, 906208, 894268, 890664, 886011, 878786, 895901, 897684, 924025, 924610, 965109, 934557, 882171, 896155, 939446, 924296, 940042, 930877, 931292, 944134, 921665, 870708, 950085, 910309, 907713, 877807, 864691, 925151, 869493, 891360, 916227, 883854, 895193, 959892, 935197, 910472, 961021, 961658, 964085, 1004910, 959787, 911636, 960754, 971216, 941883, 949984, 949860, 928120, 991974, 1006830, 1008680, 992835, 974468, 949394, 971025, 969113, 914577, 900979, 924810, 927029, 917101, 880942, 882369, 951315, 901483, 887641, 949365, 917950, 914831, 913990, 918900, 912672, 894855, 925149, 922377, 940343, 906843, 907482, 939212, 929682, 907178, 934120, 947151, 945371, 929852, 900780, 921093, 915238, 938993, 868722, 917718, 887526, 917272, 964092, 945427, 929040, 934831, 896415, 899617, 944013, 954446, 938051, 908775, 906956, 896942, 922003, 934882, 941734, 947436, 960165, 934658, 916065, 885084, 890156, 897108, 914054, 988738, 929987, 920255, 910701, 877231, 879046, 828891, 818437, 848378, 854871, 869509, 869162, 837911, 820589, 837592, 894883, 918502, 927886, 891718, 917910, 910547, 891071, 884288, 938065, 927398, 955911, 951932, 961633, 962797, 918168, 893545, 869055, 858517, 880560, 892720, 882139, 838052, 864002, 889445, 842706, 952036, 930684, 880583, 903909, 905000, 893938, 890477, 883229, 936935, 899512, 850650, 880223, 874034, 871979, 894554, 888935, 923390, 921930, 924529, 925338, 970430, 948968, 925054, 892328, 905523, 910967, 931238, 889317, 892837, 909798, 926249, 916109, 931612, 925569, 961733, 932190, 926066, 933781, 905574, 894726, 886582, 924030, 906180, 914880, 905221, 916660, 945506, 910005, 953492, 935640, 939118, 875638, 859688, 883302, 903724, 946355, 895727, 908097, 902686, 895840, 928410, 911548, 899866, 929424, 905254, 939924, 898421, 871598, 949309, 879412, 885656, 894927, 819250, 848293, 910867, 851430, 823704, 871606, 842888, 902702, 849342, 882968, 925906, 924246, 932697, 966430, 885950, 866636, 869480, 875115, 905974, 890329, 885310, 901170, 920067, 887714, 879918, 941474, 879724, 942446, 947178, 957609, 926718, 923366, 941623, 912181, 926544, 934522, 957678, 926830, 934413, 906913, 903131, 924022, 904516, 916236, 881773, 882928, 876784, 914993, 969676, 919462, 925842, 948738, 920788, 928995, 907436, 929763, 893216, 913472, 908735, 891770, 927717, 890337, 876494, 918321, 912883, 891110, 909024, 885307, 917642, 865586, 879851, 890552, 885727, 893806, 871673, 864786, 842148, 869846, 904632, 918356, 891001, 926957, 905794, 900914, 906358, 910750, 914208, 900060, 878777, 927496, 877725, 916124, 891926, 883771, 942990, 938044, 906897, 879076, 864355, 873268, 886899, 899530, 919058, 942780, 960144, 955181, 928781, 929433, 931535, 927535, 902232, 914903, 913426, 916390, 896308, 909218, 940607, 985132, 960258, 981963, 903281, 917669, 903002, 846442, 868369, 877211, 956073, 950717, 886887, 961393, 926064, 903270, 930366, 929578, 947845, 981090, 994955, 962980, 962106, 958191, 946502, 948963, 944806, 940826, 976742, 976714, 938845, 940985, 955265, 896922, 957304, 922521, 862357, 900912, 960555, 941240, 938741, 953195, 919967, 900764, 886330, 935396, 913904, 919574, 913816, 915810, 944631, 959021, 928625, 866034, 882925, 940683, 907803, 924142, 958156, 951468, 934881, 898552, 907108, 860892, 894928, 897282, 902748, 853502, 853143, 902644, 937201, 957673, 924022, 921730, 886351, 908407, 877129, 940490, 921220, 909621, 917085, 942821, 889659, 905712, 858727, 859282, 862732, 805245, 822046, 881171, 890583, 819747, 889057, 894732, 889304, 878453, 905972, 871423, 905719, 906062, 894871, 864579, 852125, 894341, 957949, 926515, 910825, 974208, 910388, 947700, 925211, 896984, 920862, 924795, 933816, 920986, 929944, 929034, 902265, 871250, 854658, 898959, 921324, 941023, 922963, 936635, 896741, 898782, 901542, 917971, 915767, 917724, 905044, 913986, 919990, 890748, 908760, 860019, 891115, 871239, 865692, 914358, 916581, 927460, 917780, 966532, 936480, 941368, 989240, 933288, 941039, 960857, 953089, 938839, 918792, 919505, 944511, 926398, 909335, 914693, 894735, 899604, 931252, 890263, 906723, 926176, 929790, 860124, 916873, 906697, 921636, 997933, 995906, 967288, 967237, 948653, 871248, 949852, 925249, 896035, 892913, 880114, 893870, 915083, 915178, 930987, 930043, 930666, 912533, 968828, 940192, 1000450, 958103, 969003, 951959, 932268, 946442, 952351, 917004, 889920, 888649, 900393, 894007, 918080, 869058, 849447, 860538, 896127, 852107, 910751, 935809, 925354, 916916, 915445, 909029, 925391, 848224, 860897, 852357, 887496, 890665, 940416, 918041, 953568, 936443, 924978, 936049, 951233, 895645, 898780, 927659, 867908), `1991` = c(762816L, 797678L, 813020L, 785498L, 788693L, 763010L, 837141L, 764554L, 737099L, 781174L, 785943L, 786928L, 796425L, 783446L, 784945L, 789536L, 739712L, 776259L, 723897L, 725513L, 766868L, 746496L, 759015L, 745036L, 770187L, 737435L, 736460L, 706814L, 749989L, 744817L, 737720L, 740142L, 783996L, 766235L, 755589L, 795808L, 774445L, 737428L, 708426L, 719352L, 721657L, 774008L, 713759L, 711519L, 730687L, 735989L, 735471L, 715663L, 762100L, 754390L, 774062L, 756001L, 785423L, 737581L, 746471L, 780567L, 807085L, 821862L, 812585L, 758139L, 780850L, 787249L, 769269L, 763337L, 739166L, 745917L, 745721L, 739229L, 764021L, 701434L, 717036L, 750839L, 744022L, 763745L, 776710L, 813985L, 804616L, 807615L, 805482L, 810613L, 835447L, 795973L, 799431L, 767652L, 802494L, 776235L, 854336L, 832642L, 804066L, 756922L, 736977L, 758839L, 742923L, 669011L, 691720L, 733493L, 761388L, 766221L, 766486L, 765250L, 763603L, 753673L, 789113L, 824242L, 799886L, 737557L, 736361L, 762008L, 779763L, 783681L, 754574L, 775067L, 788423L, 744722L, 768915L, 765684L, 709533L, 743927L, 783850L, 787229L, 761174L, 783028L, 766911L, 740487L, 773551L, 776052L, 783880L, 762525L, 784137L, 802906L, 764543L, 740463L, 743245L, 739028L, 740575L, 714698L, 746334L, 735978L, 771766L, 747172L, 718248L, 743192L, 721147L, 760769L, 797945L, 782340L, 773370L, 759157L, 760642L, 755920L, 764544L, 745522L, 771659L, 781206L, 700372L, 748828L, 719319L, 729399L, 769513L, 788171L, 759389L, 749011L, 766863L, 783669L, 790578L, 767488L, 802834L, 745916L, 749770L, 748890L, 767947L, 763464L, 784532L, 754369L, 730041L, 758709L, 698567L, 781772L, 772997L, 775262L, 784988L, 806332L, 789225L, 786956L, 799349L, 751332L, 783736L, 798780L, 746671L, 773900L, 770030L, 758459L, 774656L, 766783L, 768945L, 745795L, 757806L, 768838L, 730751L, 768174L, 770006L, 721387L, 762566L, 765935L, 734933L, 773425L, 733060L, 750811L, 757418L, 740910L, 787501L, 693214L, 731520L, 746879L, 784928L, 808500L, 807072L, 808326L, 777068L, 813324L, 770876L, 779272L, 765084L, 825640L, 813768L, 752511L, 772691L, 808273L, 794920L, 803686L, 780725L, 783407L, 779743L, 726279L, 736326L, 755483L, 794398L, 803165L, 779814L, 806372L, 750579L, 702709L, 761257L, 720333L, 738519L, 789519L, 735962L, 757918L, 742763L, 778750L, 777240L, 725864L, 727161L, 720129L, 772304L, 751126L, 741203L, 743061L, 760420L, 721641L, 737044L, 724035L, 732717L, 714730L, 766584L, 718006L, 726790L, 732182L, 745394L, 723849L, 752888L, 751889L, 794910L, 757439L, 743325L, 753022L, 743417L, 740891L, 743074L, 794884L, 811265L, 785066L, 793911L, 794623L, 792184L, 802891L, 764257L, 786061L, 769703L, 764212L, 741560L, 786464L, 750632L, 791088L, 747883L, 737877L, 740736L, 731920L, 790549L, 755480L, 780821L, 789834L, 789006L, 794361L, 818076L, 765994L, 758610L, 775356L, 773946L, 779234L, 744476L, 773131L, 715526L, 797614L, 795792L, 752112L, 769331L, 723661L, 743921L, 755217L, 706414L, 747723L, 768544L, 775357L, 783973L, 809897L, 779762L, 743914L, 712930L, 716585L, 728634L, 761442L, 717370L, 735745L, 726279L, 755404L, 740651L, 753698L, 747267L, 750082L, 709167L, 762484L, 770628L, 803918L, 773527L, 792289L, 795820L, 807199L, 784453L, 805961L, 788078L, 758542L, 769099L, 791690L, 761343L, 759524L, 767459L, 800489L, 783432L, 828977L, 836978L, 790098L, 762988L, 760342L, 740099L, 737418L, 741765L, 729168L, 769979L, 749280L, 767906L, 769294L, 756046L, 754144L, 779623L, 760478L, 769874L, 767600L, 785286L, 779672L, 806722L, 818365L, 833580L, 786890L, 787490L, 787365L, 749700L, 741876L, 788300L, 795420L, 754187L, 758748L, 756381L, 779632L, 777539L, 756487L, 775265L, 767351L, 723443L, 735224L, 724655L, 759822L, 759882L, 822782L, 825130L, 823266L, 823663L, 831969L, 800920L, 756127L, 740783L, 768874L, 775478L, 753478L, 769598L, 754695L, 731433L, 748577L, 750885L, 729558L, 737042L, 738509L, 714767L, 732556L, 745886L, 736041L, 720426L, 745728L, 746388L, 736781L, 748183L, 752894L, 728318L, 737618L, 799749L, 785532L, 743335L, 752879L, 807110L, 775834L, 791458L, 756665L, 754534L, 755288L, 753303L, 699272L, 777110L, 742181L, 771169L, 743318L, 723467L, 772289L, 728450L, 736623L, 785625L, 771456L, 789698L, 833754L, 801232L, 752961L, 804132L, 807569L, 827109L, 873737L, 829874L, 784906L, 787131L, 807270L, 798276L, 788541L, 776063L, 769560L, 830404L, 861261L, 833121L, 799992L, 793653L, 762158L, 795679L, 781811L, 751172L, 740360L, 782119L, 777656L, 786904L, 765278L, 768313L, 822061L, 788301L, 753496L, 777427L, 750046L, 762289L, 770048L, 762120L, 758400L, 770026L, 790811L, 774605L, 794546L, 745818L, 769128L, 813211L, 818371L, 774634L, 798354L, 799914L, 790520L, 771436L, 745800L, 774907L, 779127L, 802484L, 743614L, 766716L, 747931L, 761955L, 802281L, 792341L, 783897L, 799909L, 793583L, 768385L, 772353L, 784789L, 767890L, 746387L, 757631L, 736805L, 763548L, 759510L, 764576L, 767231L, 798975L, 775936L, 760883L, 742366L, 752209L, 735211L, 740154L, 830247L, 768323L, 768903L, 757006L, 707396L, 724141L, 698315L, 692874L, 741318L, 746219L, 764189L, 743398L, 714682L, 708559L, 696902L, 756270L, 755175L, 777484L, 768103L, 794302L, 766300L, 756965L, 745594L, 790378L, 795172L, 816570L, 800388L, 778876L, 783790L, 773283L, 744353L, 701722L, 711740L, 757136L, 747855L, 714890L, 682393L, 734836L, 760013L, 712475L, 802947L, 778576L, 738440L, 761698L, 761496L, 756444L, 745521L, 744488L, 780286L, 749442L, 704344L, 732069L, 727358L, 731534L, 768201L, 789818L, 758601L, 755316L, 768795L, 783803L, 850705L, 853970L, 803778L, 765914L, 786668L, 780314L, 777536L, 756446L, 786041L, 777621L, 778204L, 757828L, 778726L, 766082L, 797626L, 793411L, 781796L, 784450L, 766862L, 754244L, 741262L, 765809L, 759159L, 746960L, 722938L, 742205L, 766095L, 763412L, 779367L, 749544L, 761421L, 691520L, 683151L, 709296L, 737804L, 753475L, 713825L, 720550L, 737499L, 749433L, 778205L, 767222L, 753867L, 770020L, 734070L, 788661L, 760477L, 738603L, 798823L, 697647L, 730277L, 754668L, 698233L, 719058L, 768866L, 719169L, 686077L, 752429L, 713655L, 783770L, 718671L, 730596L, 778686L, 758933L, 774080L, 788983L, 737605L, 713804L, 737040L, 730360L, 754743L, 752064L, 742241L, 765519L, 768663L, 752049L, 726881L, 783488L, 750615L, 774732L, 782889L, 809615L, 780799L, 778366L, 782965L, 754525L, 761824L, 760911L, 787429L, 766110L, 779111L, 755188L, 761417L, 768006L, 798190L, 798276L, 740779L, 697839L, 709503L, 730995L, 771262L, 750463L, 742987L, 757812L, 741673L, 769936L, 745593L, 765938L, 751429L, 767306L, 752604L, 734467L, 768351L, 736940L, 726616L, 774829L, 775877L, 754559L, 803225L, 753261L, 792809L, 713954L, 730723L, 730101L, 731780L, 749485L, 727133L, 737665L, 716758L, 744389L, 785136L, 811337L, 795639L, 792150L, 774156L, 742876L, 764319L, 752814L, 754153L, 740739L, 748750L, 796956L, 746002L, 775514L, 761531L, 741409L, 810975L, 802110L, 769442L, 730230L, 740954L, 749377L, 745536L, 754922L, 782045L, 761770L, 780532L, 786932L, 792244L, 802859L, 793199L, 768195L, 749883L, 755948L, 770969L, 777441L, 766964L, 775792L, 777058L, 815126L, 802139L, 838209L, 787727L, 822552L, 783720L, 718191L, 743388L, 746434L, 826705L, 818467L, 744494L, 788244L, 756373L, 752827L, 770367L, 783563L, 798581L, 832264L, 837392L, 817677L, 819380L, 816459L, 816513L, 792673L, 793224L, 780999L, 807523L, 818612L, 788320L, 818724L, 813731L, 723384L, 785119L, 764848L, 729171L, 772785L, 817831L, 806871L, 795314L, 842486L, 772854L, 749088L, 768415L, 780092L, 771478L, 773613L, 761776L, 782272L, 818968L, 792675L, 771273L, 742770L, 755203L, 784871L, 770307L, 761461L, 798170L, 807255L, 786950L, 751332L, 748381L, 704308L, 747159L, 747284L, 762705L, 732879L, 706011L, 781171L, 798704L, 827244L, 791030L, 800285L, 761878L, 786267L, 726129L, 762654L, 747948L, 754212L, 745153L, 762129L, 735054L, 749083L, 712342L, 710090L, 737748L, 690069L, 693350L, 725394L, 735574L, 662711L, 721536L, 747287L, 755824L, 738668L, 770683L, 747019L, 763830L, 756949L, 746299L, 714011L, 740235L, 759726L, 801691L, 783337L, 746996L, 802118L, 755406L, 787100L, 781148L, 757749L, 765428L, 763132L, 753644L, 737403L, 763378L, 764167L, 789454L, 727497L, 701126L, 740931L, 757940L, 776991L, 764398L, 785415L, 746990L, 744820L, 747068L, 750846L, 735321L, 763776L, 762457L, 753870L, 759516L, 730114L, 759780L, 741217L, 758031L, 731560L, 716928L, 758336L, 777274L, 814847L, 776911L, 813659L, 757704L, 756358L, 820552L, 779754L, 774945L, 788576L, 783149L, 764157L, 731181L, 746865L, 786052L, 767040L, 763029L, 766829L, 734934L, 756494L, 796226L, 767882L, 767424L, 770991L, 766729L, 714164L, 788667L, 759118L, 777635L, 846656L, 841418L, 822669L, 817587L, 804571L, 745224L, 800109L, 795929L, 750666L, 748482L, 723175L, 766432L, 787581L, 782457L, 788254L, 797605L, 819977L, 806348L, 825863L, 769141L, 834438L, 789595L, 825919L, 801866L, 763094L, 767798L, 770523L, 733391L, 709170L, 729679L, 775688L, 777879L, 802968L, 764508L, 728011L, 749578L, 737031L, 715456L, 752066L, 754070L, 743468L, 744648L, 757116L, 735010L, 762376L, 691099L, 682466L, 687179L, 718042L, 712334L, 772319L, 745253L, 786686L, 821501L, 792491L, 798293L, 800141L, 742399L, 750480L, 763021L, 730494L), `1992` = c(598591L, 619719L, 620245L, 617346L, 621580L, 598671L, 673971L, 620672L, 596090L, 616894L, 632917L, 626103L, 615842L, 600813L, 622749L, 637903L, 598832L, 621310L, 552764L, 553563L, 597609L, 579441L, 576094L, 552217L, 600320L, 593294L, 604222L, 544581L, 574967L, 564463L, 554985L, 548223L, 599844L, 610582L, 589502L, 610370L, 585255L, 585776L, 571233L, 562992L, 573279L, 620132L, 544117L, 549312L, 571461L, 581990L, 561583L, 567129L, 611515L, 572487L, 598863L, 604460L, 641883L, 611604L, 624044L, 633548L, 620184L, 640537L, 644653L, 618648L, 606415L, 626851L, 600404L, 610501L, 577008L, 582577L, 581292L, 560196L, 597087L, 555074L, 581199L, 602624L, 585884L, 598242L, 593875L, 634438L, 621932L, 625685L, 616102L, 626851L, 616924L, 609088L, 614710L, 575733L, 631592L, 615766L, 677089L, 665043L, 627749L, 573384L, 548912L, 583684L, 588475L, 509546L, 536311L, 578600L, 604670L, 612334L, 603286L, 600235L, 618137L, 630137L, 631199L, 645702L, 637249L, 586168L, 572955L, 616676L, 628977L, 618592L, 592048L, 617170L, 624869L, 570357L, 597047L, 622824L, 562650L, 584359L, 639545L, 635316L, 592665L, 636022L, 627330L, 590699L, 635473L, 627034L, 629477L, 605883L, 639178L, 640357L, 622674L, 582540L, 588698L, 583088L, 588359L, 554781L, 567300L, 541069L, 579001L, 580981L, 565418L, 598657L, 555229L, 598452L, 647776L, 614971L, 610674L, 573569L, 579390L, 572209L, 589776L, 578040L, 601612L, 610885L, 547443L, 585094L, 561577L, 562834L, 624325L, 644163L, 611290L, 590511L, 622488L, 629307L, 634082L, 608273L, 642565L, 591154L, 588274L, 590299L, 621317L, 607373L, 619240L, 598907L, 580419L, 582637L, 548596L, 632498L, 631778L, 612543L, 623402L, 617956L, 605887L, 603995L, 629771L, 584842L, 634775L, 652824L, 595324L, 635715L, 609276L, 586927L, 614074L, 594769L, 587028L, 558473L, 557072L, 578074L, 559096L, 592374L, 605962L, 561041L, 607500L, 609509L, 567936L, 620383L, 574496L, 600278L, 614440L, 591514L, 624557L, 539153L, 591211L, 608703L, 639139L, 629726L, 640674L, 642436L, 628235L, 664468L, 622128L, 625537L, 627813L, 661226L, 627801L, 557730L, 571366L, 600510L, 593640L, 627768L, 618384L, 614105L, 594636L, 550823L, 568532L, 581645L, 613228L, 631136L, 605188L, 640145L, 567252L, 528160L, 572253L, 549521L, 586543L, 603464L, 596302L, 588457L, 581550L, 611957L, 606076L, 560111L, 564154L, 572595L, 624840L, 621526L, 620829L, 606572L, 614718L, 569882L, 572984L, 551378L, 576158L, 561298L, 611324L, 563012L, 554851L, 562660L, 573710L, 562187L, 586372L, 569985L, 633270L, 602520L, 581386L, 594051L, 577419L, 584524L, 569696L, 617528L, 631238L, 623913L, 637383L, 646480L, 640981L, 641836L, 591471L, 614364L, 589774L, 591085L, 581875L, 629407L, 567823L, 617921L, 609178L, 601529L, 615221L, 564273L, 602877L, 581828L, 590799L, 607142L, 614750L, 633723L, 651991L, 602362L, 610986L, 605209L, 611800L, 614564L, 608368L, 622044L, 547674L, 634553L, 631809L, 593980L, 622911L, 581172L, 585415L, 597437L, 587327L, 593394L, 610783L, 608768L, 619948L, 634704L, 606745L, 563370L, 543308L, 530934L, 545124L, 579565L, 557924L, 584857L, 568580L, 584447L, 577717L, 580262L, 570956L, 574880L, 547652L, 604304L, 613206L, 641453L, 610513L, 618916L, 627027L, 636511L, 601455L, 626776L, 604991L, 585701L, 597271L, 640060L, 598252L, 580714L, 604888L, 627526L, 619003L, 655252L, 655631L, 632834L, 604751L, 605340L, 564022L, 562300L, 589275L, 550240L, 583761L, 565148L, 577535L, 586574L, 581866L, 583271L, 608124L, 590289L, 602516L, 601994L, 598913L, 606402L, 625536L, 637137L, 674049L, 627338L, 622446L, 631863L, 612187L, 575658L, 598393L, 600496L, 565324L, 574960L, 565214L, 594731L, 603650L, 593808L, 613369L, 603333L, 540153L, 547096L, 541031L, 574175L, 582466L, 650846L, 638609L, 644550L, 663167L, 658064L, 650394L, 616505L, 601071L, 625297L, 624029L, 625815L, 651050L, 612939L, 590886L, 605913L, 586275L, 552143L, 579864L, 582911L, 578557L, 586404L, 577055L, 595134L, 576726L, 596795L, 580945L, 573328L, 599656L, 587047L, 602073L, 580977L, 637387L, 622080L, 585509L, 571861L, 631821L, 605364L, 608887L, 600814L, 615298L, 621739L, 654326L, 614929L, 659274L, 611719L, 635379L, 591357L, 560309L, 588453L, 538922L, 553848L, 595090L, 580924L, 590538L, 625016L, 601461L, 566300L, 624300L, 635095L, 656260L, 707264L, 644866L, 599571L, 622855L, 650826L, 643871L, 618117L, 622257L, 605021L, 640422L, 690670L, 655649L, 625558L, 619827L, 597727L, 639123L, 659759L, 635245L, 633791L, 659158L, 618275L, 628321L, 622459L, 617950L, 655616L, 621356L, 584250L, 622083L, 582763L, 604500L, 615975L, 599067L, 578538L, 620703L, 624358L, 603328L, 639049L, 590138L, 612685L, 635772L, 639009L, 597256L, 648120L, 644918L, 645455L, 614643L, 598907L, 617614L, 613877L, 628263L, 549134L, 585908L, 591654L, 593245L, 631742L, 613108L, 620194L, 636735L, 630041L, 612982L, 604571L, 616566L, 591978L, 585584L, 609271L, 582530L, 585504L, 595229L, 606305L, 602916L, 614201L, 610349L, 586892L, 574930L, 608046L, 560148L, 597183L, 675876L, 612242L, 585964L, 566709L, 529549L, 571374L, 571050L, 542432L, 585125L, 587947L, 604818L, 590549L, 573839L, 563228L, 546571L, 591354L, 584606L, 616957L, 596320L, 607393L, 600196L, 593772L, 590063L, 636128L, 611440L, 625628L, 609897L, 590353L, 598246L, 597804L, 592186L, 572161L, 573039L, 608805L, 594688L, 572016L, 519283L, 550315L, 575241L, 574773L, 645037L, 647923L, 579351L, 596229L, 597001L, 588560L, 569748L, 569423L, 615017L, 616529L, 550860L, 574375L, 574998L, 549508L, 587410L, 619645L, 592504L, 586285L, 601913L, 598336L, 660599L, 666602L, 620157L, 587930L, 623194L, 610069L, 619839L, 609701L, 640569L, 644626L, 664545L, 625656L, 658141L, 627443L, 654209L, 640106L, 619583L, 633090L, 616792L, 582289L, 550599L, 579454L, 591661L, 580714L, 560335L, 569008L, 584717L, 591795L, 616593L, 598605L, 614880L, 547766L, 536564L, 566885L, 601336L, 631560L, 559279L, 583893L, 581827L, 584636L, 608507L, 598189L, 589745L, 625040L, 591803L, 624023L, 622621L, 561248L, 647713L, 581337L, 602624L, 630280L, 579871L, 591355L, 629703L, 577722L, 564598L, 628717L, 556594L, 623281L, 542944L, 569760L, 617587L, 594849L, 617795L, 636740L, 611604L, 591417L, 599896L, 582448L, 591123L, 605789L, 608055L, 620525L, 610998L, 593551L, 589581L, 624050L, 609699L, 622473L, 623559L, 638928L, 611606L, 644163L, 638296L, 626543L, 624437L, 630544L, 641567L, 612729L, 629930L, 594163L, 622390L, 620108L, 665434L, 655310L, 603343L, 596277L, 593494L, 590760L, 625964L, 580186L, 590276L, 582631L, 566575L, 617658L, 597279L, 614578L, 624878L, 590258L, 585461L, 586156L, 598507L, 568584L, 562151L, 601641L, 598390L, 574932L, 621486L, 567507L, 648528L, 565922L, 580304L, 559064L, 553588L, 562719L, 545127L, 572305L, 550991L, 577227L, 614670L, 620607L, 603619L, 626039L, 612532L, 597198L, 624576L, 621380L, 625071L, 621504L, 600975L, 629408L, 583450L, 609125L, 614604L, 599191L, 634046L, 619880L, 597322L, 551595L, 583869L, 597748L, 601845L, 595079L, 626071L, 601818L, 601569L, 598318L, 602818L, 630685L, 594626L, 562416L, 534798L, 555927L, 581154L, 586474L, 577185L, 606895L, 600760L, 638274L, 620061L, 648532L, 603330L, 683268L, 631967L, 578851L, 591407L, 592290L, 664346L, 644826L, 608632L, 644522L, 592706L, 592075L, 619212L, 613380L, 620148L, 661563L, 668723L, 639396L, 644819L, 642974L, 646715L, 626406L, 636654L, 636590L, 640108L, 659436L, 634654L, 655329L, 647392L, 585181L, 624118L, 597632L, 572104L, 607076L, 632672L, 633142L, 642121L, 671636L, 600205L, 572276L, 582427L, 594796L, 596683L, 625278L, 606533L, 612176L, 646254L, 629517L, 621344L, 583249L, 591552L, 633566L, 633027L, 618865L, 639678L, 649840L, 626050L, 579845L, 600472L, 556770L, 598807L, 579067L, 596545L, 584495L, 561069L, 601733L, 625839L, 662630L, 639587L, 631189L, 618443L, 627758L, 565466L, 605401L, 589691L, 605753L, 577081L, 593835L, 553049L, 552066L, 519666L, 526666L, 548586L, 497718L, 523065L, 555200L, 560869L, 495832L, 546427L, 581995L, 579113L, 568953L, 604592L, 594698L, 603726L, 601669L, 621885L, 578993L, 625294L, 607029L, 636504L, 629241L, 586331L, 666111L, 614127L, 632749L, 640611L, 609512L, 607756L, 580144L, 581677L, 570787L, 610951L, 612967L, 643725L, 577887L, 553298L, 593360L, 594676L, 604522L, 587226L, 605061L, 572377L, 573671L, 576682L, 608969L, 573764L, 592878L, 580855L, 602815L, 585377L, 576919L, 609222L, 561912L, 590294L, 572576L, 533834L, 561949L, 573154L, 603657L, 563943L, 603900L, 555937L, 554596L, 635306L, 615838L, 596158L, 612555L, 607910L, 597867L, 581080L, 590472L, 611205L, 593491L, 624331L, 638191L, 586045L, 611051L, 644787L, 617876L, 602538L, 604688L, 607617L, 563189L, 641203L, 605308L, 639800L, 694360L, 695480L, 657955L, 659169L, 621818L, 595213L, 627722L, 634002L, 582810L, 581077L, 566606L, 592795L, 619547L, 607625L, 615432L, 626292L, 659977L, 629053L, 639993L, 582101L, 638385L, 612354L, 657465L, 627809L, 596822L, 618302L, 627771L, 559774L, 531152L, 576155L, 617683L, 603501L, 629354L, 617031L, 577120L, 601702L, 588034L, 580041L, 596546L, 588026L, 593562L, 578553L, 589231L, 565546L, 597201L, 557908L, 556647L, 568104L, 592314L, 569775L, 624088L, 582380L, 623707L, 643155L, 623374L, 623564L, 607850L, 561233L, 568142L, 600988L, 554150L), `1993` = c(630708L, 675259L, 673733L, 663769L, 652591L, 642041L, 707764L, 686546L, 643556L, 650643L, 655591L, 666620L, 649721L, 641303L, 681680L, 698310L, 690839L, 689334L, 629873L, 590954L, 619160L, 585775L, 575325L, 567645L, 602510L, 605926L, 607309L, 581511L, 600153L, 596308L, 609033L, 595206L, 615006L, 625246L, 584239L, 560515L, 575577L, 612865L, 597096L, 595019L, 637420L, 688245L, 622084L, 638404L, 652298L, 637102L, 594188L, 597743L, 621698L, 607498L, 634428L, 600140L, 645917L, 634147L, 613169L, 651817L, 647762L, 672231L, 692637L, 690064L, 677221L, 668462L, 621109L, 639558L, 602328L, 616025L, 610935L, 619954L, 631177L, 609495L, 630968L, 669954L, 634262L, 615506L, 588187L, 620210L, 616394L, 628862L, 641730L, 652078L, 624006L, 611388L, 628226L, 565778L, 617234L, 613208L, 687763L, 646793L, 651072L, 621921L, 597896L, 613424L, 631837L, 599740L, 578585L, 622160L, 635712L, 651645L, 617810L, 630712L, 647830L, 639657L, 647925L, 663986L, 676796L, 600841L, 608806L, 651201L, 689015L, 654155L, 606417L, 638055L, 644945L, 569311L, 617525L, 678213L, 628820L, 607780L, 654935L, 658658L, 625313L, 643545L, 621330L, 594824L, 639691L, 647100L, 669949L, 673557L, 701087L, 707420L, 636664L, 607502L, 629599L, 641243L, 623614L, 595259L, 606705L, 565017L, 580647L, 609038L, 600801L, 628099L, 573276L, 635581L, 665893L, 614514L, 623978L, 597168L, 607857L, 610277L, 612595L, 594550L, 637942L, 648166L, 630956L, 655635L, 625066L, 612739L, 667763L, 659828L, 629481L, 622557L, 699507L, 647794L, 633494L, 601343L, 669535L, 605888L, 625041L, 646387L, 679838L, 661911L, 650678L, 623681L, 608588L, 618308L, 576168L, 650176L, 653687L, 639661L, 643867L, 647935L, 652589L, 650920L, 655231L, 615166L, 674800L, 690271L, 639548L, 704043L, 667694L, 663223L, 688855L, 672864L, 651152L, 622050L, 623216L, 649673L, 629492L, 626307L, 619083L, 568204L, 622903L, 638524L, 586245L, 664415L, 605398L, 631718L, 662397L, 652990L, 665218L, 573950L, 630093L, 625920L, 674658L, 677803L, 693719L, 698023L, 654155L, 679053L, 610573L, 617394L, 620177L, 665659L, 646593L, 562789L, 596567L, 634127L, 615295L, 645605L, 644350L, 645630L, 627093L, 579068L, 594669L, 607618L, 632758L, 672318L, 642711L, 668716L, 615266L, 574048L, 609077L, 556815L, 610899L, 594692L, 602865L, 590040L, 600340L, 624991L, 629680L, 607056L, 586057L, 589115L, 639402L, 646951L, 653907L, 640014L, 637468L, 625339L, 613135L, 600904L, 658450L, 618120L, 653687L, 592757L, 564174L, 588149L, 613682L, 564642L, 588655L, 566901L, 637059L, 623248L, 612984L, 656634L, 639269L, 631451L, 598905L, 653580L, 670157L, 654870L, 645286L, 658368L, 656898L, 647493L, 611701L, 620598L, 609251L, 612782L, 597983L, 637771L, 543303L, 617433L, 611859L, 611976L, 632135L, 583593L, 635574L, 609296L, 651815L, 644961L, 617399L, 638978L, 689418L, 634735L, 651884L, 613549L, 667695L, 683609L, 682876L, 681867L, 603541L, 701812L, 663937L, 626868L, 678227L, 650844L, 646429L, 647381L, 629756L, 676825L, 699349L, 632206L, 648238L, 652060L, 658293L, 615675L, 607535L, 612312L, 628794L, 641600L, 617434L, 617841L, 627314L, 610995L, 602270L, 598739L, 562453L, 580777L, 586336L, 650963L, 659641L, 677473L, 656289L, 678006L, 690578L, 698112L, 643739L, 687271L, 658103L, 619224L, 623615L, 694543L, 650198L, 597013L, 614478L, 631339L, 625514L, 646535L, 647835L, 655981L, 617774L, 646478L, 619136L, 604378L, 624135L, 588987L, 626133L, 608701L, 624146L, 660240L, 662611L, 632964L, 645451L, 638059L, 656616L, 671071L, 665581L, 661233L, 666656L, 672588L, 690849L, 648071L, 623496L, 645110L, 654289L, 623444L, 639894L, 644339L, 603497L, 600991L, 601363L, 621171L, 620992L, 613680L, 661682L, 651948L, 595311L, 573734L, 599528L, 605138L, 605423L, 688036L, 658810L, 656461L, 657192L, 642470L, 649103L, 609495L, 616683L, 631315L, 612983L, 610156L, 631346L, 608685L, 593618L, 625031L, 634955L, 630707L, 607101L, 625624L, 645465L, 644311L, 626457L, 644931L, 598999L, 637093L, 624829L, 619844L, 637923L, 634822L, 636724L, 601195L, 627331L, 624767L, 595445L, 606095L, 666172L, 651920L, 651303L, 616622L, 643046L, 654674L, 671073L, 645836L, 688383L, 641200L, 699994L, 639500L, 601871L, 618320L, 581719L, 613162L, 633653L, 593579L, 597351L, 623724L, 624062L, 612262L, 617011L, 655884L, 681389L, 726678L, 662496L, 612530L, 626078L, 659980L, 637534L, 607869L, 634207L, 621363L, 662186L, 740190L, 717870L, 662974L, 662209L, 605485L, 650521L, 699713L, 645640L, 655570L, 693452L, 644901L, 656109L, 647729L, 654516L, 685440L, 640080L, 620746L, 636072L, 606585L, 610397L, 599635L, 595980L, 578526L, 650221L, 674926L, 623673L, 667624L, 609300L, 639081L, 676781L, 692153L, 627428L, 675734L, 673199L, 665423L, 634852L, 630304L, 670716L, 677245L, 697727L, 613594L, 645180L, 646947L, 636400L, 661918L, 622083L, 629947L, 639818L, 635770L, 639584L, 627209L, 632646L, 648974L, 647452L, 685457L, 635486L, 612357L, 639323L, 629024L, 639774L, 636368L, 671398L, 646850L, 640307L, 658727L, 594082L, 673647L, 730411L, 675289L, 620310L, 613739L, 588222L, 624227L, 613117L, 575749L, 607547L, 585929L, 605730L, 580816L, 582351L, 584145L, 543770L, 568930L, 564707L, 605820L, 587558L, 601852L, 625100L, 619413L, 617463L, 642209L, 619083L, 636046L, 625633L, 614449L, 601951L, 605043L, 598477L, 612533L, 612839L, 656335L, 667067L, 635306L, 597759L, 615634L, 616607L, 603139L, 662365L, 687177L, 609564L, 611791L, 601639L, 610656L, 600102L, 605789L, 646970L, 651136L, 615585L, 629270L, 649099L, 621301L, 648736L, 665875L, 661360L, 639423L, 675558L, 655402L, 702728L, 737709L, 690217L, 625317L, 655604L, 616123L, 643278L, 618143L, 648592L, 684052L, 691972L, 647835L, 712739L, 626999L, 669829L, 649333L, 636434L, 675785L, 662387L, 613970L, 570972L, 615454L, 609778L, 631876L, 601249L, 606811L, 636844L, 642063L, 652631L, 632959L, 655051L, 586329L, 596814L, 612821L, 644980L, 651905L, 572914L, 621449L, 582690L, 606348L, 647191L, 652200L, 661267L, 683264L, 637802L, 672899L, 699042L, 606630L, 703329L, 652161L, 660804L, 693198L, 644987L, 679238L, 720189L, 623816L, 621919L, 689729L, 596214L, 664324L, 587504L, 574661L, 626810L, 644203L, 648913L, 661189L, 635153L, 591987L, 587734L, 583144L, 572515L, 596148L, 606270L, 632504L, 631826L, 618424L, 615753L, 629448L, 605276L, 627953L, 622847L, 651113L, 630609L, 657864L, 649698L, 651624L, 654579L, 672573L, 675639L, 611678L, 637397L, 614261L, 666205L, 637612L, 693986L, 666427L, 626702L, 631382L, 636558L, 615130L, 620782L, 585716L, 627284L, 596324L, 589479L, 665663L, 648525L, 646916L, 661081L, 632949L, 615250L, 632247L, 625394L, 610006L, 620482L, 634439L, 666361L, 639735L, 696873L, 616280L, 708361L, 610104L, 620634L, 607588L, 585639L, 598564L, 585855L, 595617L, 593490L, 618395L, 628766L, 645463L, 637678L, 680522L, 644462L, 630719L, 632031L, 631877L, 675489L, 651078L, 626352L, 649088L, 585014L, 632117L, 637898L, 632239L, 658084L, 651234L, 658579L, 613505L, 651194L, 651167L, 649757L, 619969L, 654824L, 632822L, 623427L, 593178L, 635554L, 611247L, 589266L, 557248L, 542561L, 589018L, 611727L, 584571L, 601275L, 657035L, 633446L, 672276L, 653359L, 680138L, 620354L, 698212L, 671748L, 598309L, 634339L, 643153L, 714720L, 672404L, 698436L, 694270L, 647724L, 644399L, 661480L, 628737L, 632037L, 672825L, 655988L, 592225L, 586312L, 597781L, 620036L, 607004L, 632318L, 658941L, 640836L, 648794L, 652858L, 657776L, 656348L, 594135L, 630263L, 618577L, 602735L, 647361L, 645389L, 638737L, 664951L, 717940L, 621731L, 584421L, 586840L, 615625L, 608479L, 668913L, 639039L, 622365L, 656857L, 653578L, 631169L, 583367L, 589002L, 632676L, 654143L, 647295L, 638406L, 654420L, 668933L, 652720L, 659851L, 689513L, 674237L, 625229L, 651439L, 612067L, 609215L, 626845L, 677461L, 692883L, 686652L, 689947L, 687891L, 696879L, 613382L, 625088L, 624109L, 632698L, 619777L, 618500L, 578153L, 598593L, 570898L, 584811L, 640581L, 579290L, 620768L, 647179L, 638846L, 549352L, 582405L, 610876L, 592472L, 581647L, 617999L, 614050L, 610852L, 608195L, 636569L, 586496L, 631711L, 617334L, 664699L, 666526L, 631284L, 716284L, 647042L, 664304L, 658879L, 643392L, 626098L, 595714L, 616261L, 613925L, 648317L, 650895L, 681649L, 614780L, 585922L, 641774L, 661555L, 665220L, 630792L, 655039L, 603923L, 637918L, 623648L, 648047L, 607764L, 619472L, 613146L, 638011L, 621997L, 617037L, 640776L, 582974L, 618511L, 611235L, 579932L, 600671L, 620013L, 635911L, 598667L, 599162L, 540836L, 534834L, 638821L, 622027L, 626029L, 634286L, 630489L, 630831L, 647330L, 630639L, 666657L, 614156L, 662696L, 702369L, 651583L, 662801L, 710842L, 667848L, 644292L, 652420L, 654496L, 604313L, 669447L, 640849L, 647179L, 717086L, 715451L, 689944L, 676623L, 624342L, 636334L, 644799L, 692317L, 651887L, 648210L, 631257L, 634622L, 646026L, 639456L, 622348L, 625850L, 664146L, 634108L, 611249L, 565860L, 636704L, 623434L, 684995L, 645551L, 627057L, 645514L, 650590L, 623587L, 566449L, 600500L, 630062L, 622566L, 645888L, 658593L, 586543L, 650485L, 652844L, 633587L, 653241L, 638150L, 632593L, 626369L, 644302L, 604852L, 640265L, 592216L, 583328L, 623490L, 677722L, 655455L, 717323L, 646955L, 676525L, 674215L, 683745L, 673094L, 655825L, 587507L, 563684L, 616593L, 571255L), `1994` = c(642020L, 716512L, 716189L, 656622L, 626623L, 641897L, 707966L, 707318L, 631161L, 690194L, 701724L, 689105L, 679156L, 658514L, 684838L, 696144L, 672610L, 696930L, 615669L, 574528L, 620181L, 580885L, 581751L, 575170L, 619945L, 623506L, 605861L, 568034L, 604015L, 600809L, 630904L, 593641L, 599989L, 619290L, 580863L, 606570L, 603073L, 674336L, 625854L, 643942L, 668925L, 693476L, 605032L, 632247L, 661391L, 638987L, 610169L, 616510L, 638412L, 629475L, 643354L, 581815L, 641648L, 628136L, 639020L, 652568L, 623141L, 646278L, 683828L, 673398L, 648976L, 645420L, 606440L, 632330L, 598073L, 643069L, 640776L, 644754L, 632921L, 640986L, 652575L, 694679L, 665783L, 627052L, 591741L, 644120L, 626685L, 636128L, 658983L, 662864L, 629329L, 607596L, 596255L, 525069L, 593681L, 624420L, 673187L, 649365L, 656608L, 636124L, 612455L, 616096L, 661929L, 622328L, 583896L, 655890L, 649065L, 672663L, 639109L, 635205L, 677637L, 683267L, 664910L, 673521L, 683646L, 623393L, 631263L, 675270L, 708630L, 678273L, 642365L, 672652L, 659956L, 565564L, 619136L, 674738L, 633559L, 609755L, 613077L, 624941L, 599444L, 628641L, 616530L, 611056L, 643125L, 684100L, 684360L, 684142L, 718402L, 712136L, 627948L, 630164L, 627971L, 622450L, 622842L, 607750L, 611252L, 592533L, 602044L, 617533L, 610478L, 644505L, 624387L, 651335L, 663004L, 614023L, 594767L, 578104L, 605554L, 637031L, 638939L, 601011L, 659256L, 645964L, 637307L, 639977L, 625061L, 611329L, 669758L, 697907L, 653163L, 627815L, 683063L, 642201L, 652843L, 597392L, 654433L, 620211L, 661234L, 670040L, 675881L, 650411L, 646118L, 641467L, 629995L, 651672L, 599981L, 672011L, 681217L, 659659L, 634884L, 639361L, 633482L, 674506L, 677490L, 628973L, 702521L, 730656L, 673110L, 745139L, 700128L, 678438L, 664934L, 663756L, 658176L, 640834L, 654360L, 646652L, 637974L, 639621L, 631954L, 583275L, 629407L, 652409L, 604782L, 695713L, 618275L, 636164L, 656230L, 639595L, 650057L, 596493L, 650278L, 629921L, 672936L, 691660L, 670095L, 656866L, 625055L, 635089L, 575267L, 598081L, 598083L, 670062L, 635497L, 596988L, 615672L, 673915L, 646692L, 660355L, 664097L, 670050L, 646454L, 609082L, 608086L, 601320L, 606698L, 631993L, 633090L, 649169L, 612938L, 602068L, 639882L, 574699L, 628688L, 587804L, 593156L, 583869L, 589574L, 632161L, 643200L, 650179L, 630258L, 630718L, 666782L, 665052L, 698338L, 683770L, 648218L, 641814L, 637083L, 625386L, 676698L, 632008L, 677143L, 631299L, 617747L, 616845L, 627660L, 592032L, 627172L, 621612L, 676253L, 637685L, 638800L, 676579L, 661634L, 675992L, 627488L, 677135L, 680694L, 646514L, 673794L, 695445L, 684170L, 661164L, 634866L, 621629L, 593135L, 596790L, 589154L, 633655L, 543337L, 658365L, 629620L, 640338L, 678945L, 594754L, 623693L, 605326L, 667861L, 663648L, 627479L, 652787L, 668070L, 644619L, 681831L, 631615L, 656651L, 672257L, 670174L, 687103L, 607622L, 707652L, 658440L, 623812L, 664356L, 639702L, 638085L, 661488L, 640741L, 684494L, 692311L, 638795L, 688996L, 691069L, 671515L, 636534L, 631246L, 640643L, 666645L, 670517L, 619579L, 616081L, 639257L, 641053L, 616973L, 623244L, 545186L, 547291L, 560731L, 608793L, 628917L, 640611L, 625007L, 665130L, 681959L, 697052L, 638886L, 672658L, 633530L, 592302L, 599560L, 678828L, 642831L, 641648L, 642515L, 637392L, 646220L, 649152L, 645210L, 653852L, 616598L, 626671L, 607109L, 605023L, 621073L, 594622L, 630188L, 612922L, 660641L, 679146L, 693102L, 636395L, 645733L, 630135L, 650647L, 656448L, 650804L, 627615L, 625827L, 661806L, 679710L, 696018L, 628441L, 658487L, 653047L, 677945L, 688110L, 666183L, 659216L, 623886L, 595271L, 626516L, 641254L, 622428L, 684180L, 692760L, 630349L, 600972L, 623171L, 617182L, 597339L, 677025L, 634548L, 630010L, 630623L, 646763L, 627409L, 580804L, 606112L, 628367L, 611383L, 596955L, 626177L, 596731L, 596791L, 584997L, 594005L, 615645L, 604542L, 612298L, 636076L, 649433L, 592584L, 658369L, 635483L, 658318L, 634126L, 635072L, 638202L, 630480L, 632516L, 621786L, 647977L, 643096L, 602185L, 644544L, 673918L, 640872L, 674706L, 633096L, 656865L, 662040L, 666721L, 641844L, 692941L, 661331L, 708036L, 672486L, 629309L, 645443L, 617019L, 629196L, 642880L, 616092L, 604026L, 636384L, 639355L, 625304L, 604131L, 671814L, 721591L, 756591L, 692408L, 655519L, 686331L, 667151L, 648497L, 629147L, 656569L, 622154L, 628430L, 723536L, 712767L, 656627L, 651729L, 617640L, 673399L, 711421L, 629583L, 625637L, 675010L, 645900L, 642382L, 606307L, 645728L, 676159L, 620022L, 625907L, 634047L, 593893L, 602017L, 593858L, 597182L, 592491L, 654890L, 678912L, 636111L, 650571L, 601635L, 613022L, 660716L, 666635L, 621438L, 672821L, 678682L, 679964L, 656795L, 635262L, 649603L, 689061L, 707387L, 643827L, 684241L, 665060L, 650386L, 678858L, 630773L, 639387L, 647980L, 648050L, 671554L, 667637L, 672404L, 645909L, 652828L, 699375L, 655833L, 617806L, 653986L, 659298L, 660283L, 644084L, 691209L, 660390L, 652734L, 643921L, 589740L, 695536L, 760007L, 707914L, 650311L, 645459L, 618019L, 645540L, 637073L, 600854L, 643949L, 624524L, 640098L, 623818L, 632062L, 638885L, 573678L, 602119L, 566263L, 607128L, 598418L, 598348L, 609578L, 601462L, 598043L, 623853L, 593003L, 630111L, 630886L, 615456L, 612540L, 614479L, 617399L, 625242L, 613808L, 660860L, 677484L, 662311L, 633071L, 667870L, 637987L, 599052L, 700767L, 726235L, 655522L, 625472L, 613916L, 637879L, 638654L, 633508L, 674309L, 669347L, 674472L, 679026L, 695622L, 652455L, 666453L, 672093L, 660030L, 626132L, 687447L, 686167L, 741921L, 735631L, 722381L, 666084L, 694104L, 689498L, 693505L, 636150L, 680072L, 702339L, 686687L, 646222L, 707090L, 617706L, 663027L, 649040L, 637632L, 669350L, 653352L, 620650L, 597831L, 642526L, 618745L, 659218L, 613587L, 630816L, 660409L, 653205L, 697155L, 666984L, 677038L, 647621L, 638952L, 631353L, 672961L, 693872L, 615090L, 665644L, 593153L, 599903L, 630909L, 648865L, 661294L, 679477L, 646622L, 662658L, 709921L, 639167L, 711831L, 666772L, 686840L, 690723L, 653109L, 684549L, 720393L, 621330L, 612889L, 660292L, 589016L, 633264L, 605197L, 629744L, 641935L, 658410L, 652692L, 647515L, 646676L, 612345L, 606882L, 606878L, 573418L, 594225L, 622481L, 654231L, 617246L, 602157L, 606130L, 592996L, 566173L, 615457L, 628862L, 663907L, 654456L, 675218L, 676378L, 687088L, 658962L, 694151L, 688555L, 669685L, 672500L, 629152L, 683772L, 659045L, 716616L, 671818L, 607165L, 597592L, 643809L, 626909L, 614074L, 584228L, 678712L, 613368L, 614043L, 682850L, 645769L, 656267L, 680322L, 658979L, 655003L, 656838L, 674455L, 653061L, 642605L, 666583L, 694047L, 667063L, 716348L, 645869L, 737338L, 661967L, 658657L, 638253L, 622336L, 616552L, 603997L, 615379L, 609546L, 649001L, 640194L, 664502L, 659868L, 694731L, 687712L, 652933L, 657797L, 646366L, 731179L, 673558L, 649879L, 678548L, 606290L, 655863L, 666515L, 645456L, 669993L, 668259L, 694184L, 683564L, 713882L, 693550L, 671169L, 647856L, 641189L, 622085L, 621673L, 614710L, 637775L, 640258L, 621047L, 626447L, 619774L, 643755L, 650716L, 621304L, 658711L, 688790L, 662799L, 708251L, 662661L, 692419L, 603570L, 726433L, 643333L, 629583L, 645530L, 652619L, 739326L, 705976L, 722533L, 711830L, 664566L, 645837L, 637613L, 623670L, 620170L, 670828L, 649699L, 590478L, 601527L, 615583L, 627929L, 637158L, 643385L, 675826L, 635334L, 650504L, 661401L, 651496L, 637950L, 601209L, 624660L, 631798L, 619423L, 679781L, 650062L, 634538L, 632505L, 709509L, 629542L, 608472L, 621643L, 641945L, 650023L, 676694L, 651928L, 656914L, 667439L, 651875L, 639469L, 597601L, 606343L, 665522L, 696003L, 692606L, 658606L, 657031L, 656118L, 655693L, 665651L, 680510L, 657051L, 623515L, 617113L, 579171L, 580351L, 580554L, 638471L, 647457L, 630781L, 642408L, 625171L, 642570L, 580344L, 614708L, 597484L, 610314L, 612879L, 642082L, 610184L, 630994L, 581997L, 612276L, 655447L, 604299L, 656158L, 676080L, 630341L, 541192L, 563493L, 587155L, 579609L, 584769L, 606351L, 619497L, 620410L, 624047L, 660337L, 647860L, 644621L, 650649L, 715541L, 654721L, 604463L, 690630L, 587721L, 610972L, 613045L, 596201L, 600603L, 571493L, 588239L, 582552L, 624275L, 638626L, 681239L, 616110L, 596860L, 640181L, 661546L, 669012L, 640060L, 668802L, 626618L, 679209L, 644462L, 690792L, 629130L, 634505L, 620835L, 660357L, 641763L, 634315L, 665971L, 623357L, 642226L, 646009L, 605764L, 619543L, 658112L, 685363L, 655677L, 672094L, 581956L, 549781L, 629985L, 613303L, 612768L, 597800L, 591334L, 611348L, 618415L, 609530L, 650146L, 603505L, 647416L, 697556L, 650982L, 658324L, 719239L, 702090L, 656011L, 665592L, 650490L, 603996L, 673672L, 643082L, 625141L, 719701L, 717337L, 693764L, 693210L, 650853L, 651504L, 661190L, 733017L, 694054L, 689165L, 646931L, 644889L, 664958L, 650374L, 615058L, 620307L, 666047L, 631389L, 604027L, 579770L, 642573L, 606590L, 695734L, 667488L, 626204L, 637219L, 645218L, 620529L, 577433L, 605050L, 621311L, 605627L, 639533L, 645533L, 586405L, 661448L, 677770L, 650178L, 674380L, 675186L, 642903L, 640009L, 651915L, 621439L, 683960L, 596670L, 587998L, 615790L, 666176L, 653824L, 696520L, 631257L, 672211L, 666115L, 704781L, 708788L, 668643L, 624440L, 630047L, 670945L, 643641L), `1995` = c(613469L, 695090L, 675160L, 627243L, 595998L, 607858L, 680828L, 702958L, 619170L, 676089L, 670106L, 662875L, 651049L, 621844L, 645581L, 646262L, 611130L, 664908L, 566085L, 535873L, 572785L, 543828L, 555416L, 567684L, 578151L, 572161L, 571731L, 529896L, 572746L, 576275L, 603296L, 574082L, 589090L, 613444L, 548362L, 582154L, 599540L, 668213L, 599563L, 616587L, 637380L, 672803L, 567895L, 590503L, 626839L, 600786L, 563640L, 564491L, 602529L, 608556L, 620712L, 560255L, 610206L, 586812L, 623645L, 631010L, 589344L, 641115L, 676529L, 653925L, 636249L, 642376L, 599660L, 641788L, 603007L, 628905L, 614861L, 625575L, 617147L, 639247L, 625429L, 674903L, 656558L, 605443L, 546384L, 619111L, 603784L, 604421L, 626967L, 623108L, 592433L, 574198L, 550804L, 480385L, 572889L, 601453L, 637052L, 607252L, 636648L, 649321L, 612203L, 598053L, 657344L, 608194L, 563829L, 624647L, 629392L, 675343L, 624119L, 611173L, 662028L, 656410L, 636642L, 641191L, 657738L, 606747L, 616162L, 674445L, 702869L, 649308L, 622040L, 649878L, 631734L, 531850L, 587773L, 638760L, 606516L, 601506L, 574185L, 571447L, 546452L, 572022L, 566599L, 574223L, 621044L, 661329L, 653314L, 635457L, 659891L, 671346L, 639667L, 620692L, 616273L, 602023L, 609976L, 597984L, 607640L, 579971L, 584552L, 597828L, 588846L, 611394L, 604763L, 640740L, 639685L, 579036L, 567756L, 575152L, 606743L, 642086L, 611109L, 574720L, 646165L, 651704L, 633388L, 641117L, 631881L, 608500L, 642341L, 671777L, 629071L, 602645L, 680298L, 633515L, 643513L, 598682L, 627837L, 612143L, 645933L, 673399L, 658141L, 620919L, 600738L, 609323L, 585572L, 621306L, 563463L, 639819L, 631560L, 617542L, 609441L, 616081L, 614881L, 668561L, 662852L, 601943L, 673878L, 700551L, 641522L, 717771L, 670553L, 656648L, 625492L, 640358L, 622473L, 607566L, 636002L, 608980L, 613545L, 622018L, 611035L, 582173L, 623170L, 640824L, 575773L, 671725L, 598625L, 617300L, 629916L, 633614L, 622418L, 562392L, 618733L, 597016L, 647193L, 666363L, 618950L, 598490L, 576474L, 568552L, 526866L, 547801L, 552073L, 608204L, 598936L, 584850L, 621743L, 650011L, 621925L, 625476L, 631743L, 642562L, 606872L, 561965L, 583990L, 588038L, 594321L, 600482L, 603328L, 622220L, 593226L, 570372L, 616284L, 555403L, 602163L, 542919L, 569210L, 555155L, 558899L, 609089L, 608302L, 616820L, 603497L, 586036L, 610620L, 618430L, 676899L, 670806L, 616139L, 603569L, 609405L, 574959L, 620789L, 585003L, 634221L, 596995L, 581161L, 579435L, 577515L, 559687L, 602365L, 569138L, 624362L, 598250L, 602826L, 646904L, 641109L, 667721L, 603849L, 647698L, 646876L, 618629L, 647536L, 655843L, 643259L, 617200L, 582146L, 596458L, 570800L, 588078L, 570987L, 620238L, 508470L, 632383L, 612634L, 603992L, 657851L, 572686L, 604318L, 580340L, 643891L, 647480L, 584203L, 636620L, 645603L, 603706L, 650415L, 593517L, 625179L, 634501L, 636606L, 655630L, 567308L, 663704L, 617265L, 576552L, 622560L, 606723L, 609174L, 623377L, 617337L, 665469L, 675439L, 595754L, 652134L, 659167L, 649390L, 605581L, 616432L, 610007L, 630153L, 641808L, 604278L, 593118L, 615931L, 629691L, 598214L, 605465L, 536112L, 544239L, 538712L, 579827L, 606919L, 611477L, 592276L, 647587L, 654389L, 675795L, 627966L, 660642L, 612015L, 558180L, 557073L, 622950L, 600185L, 599691L, 611966L, 589472L, 608679L, 626791L, 633913L, 631584L, 595998L, 591580L, 579288L, 560132L, 565001L, 554736L, 606319L, 598628L, 651342L, 666497L, 669153L, 600187L, 606605L, 601475L, 620115L, 627554L, 600900L, 589866L, 578697L, 614619L, 645479L, 672289L, 606094L, 626570L, 603365L, 623758L, 624224L, 619885L, 616296L, 566538L, 533014L, 566373L, 577289L, 575672L, 654365L, 664257L, 591790L, 585369L, 616371L, 595191L, 572232L, 644798L, 604067L, 611923L, 611401L, 630473L, 622278L, 558278L, 552413L, 585601L, 571036L, 558224L, 602700L, 589732L, 589908L, 573600L, 581260L, 575114L, 563550L, 589165L, 606396L, 627622L, 600904L, 617988L, 614191L, 626827L, 604537L, 604760L, 593688L, 589408L, 597843L, 591585L, 618256L, 638509L, 594897L, 614798L, 636413L, 603616L, 653781L, 594101L, 623795L, 637755L, 628713L, 615800L, 654886L, 631198L, 672625L, 652659L, 601668L, 602125L, 579146L, 583913L, 583992L, 555341L, 539848L, 585688L, 595915L, 602779L, 572561L, 651056L, 702480L, 727722L, 658565L, 634089L, 666864L, 624562L, 614175L, 607935L, 626339L, 590869L, 588554L, 691479L, 683086L, 623325L, 631657L, 598238L, 650594L, 694004L, 607419L, 586530L, 649155L, 616750L, 597769L, 567701L, 600551L, 634912L, 564583L, 576751L, 594722L, 559255L, 567548L, 552864L, 540856L, 527683L, 599937L, 625590L, 585225L, 596447L, 550749L, 556969L, 612650L, 630242L, 583808L, 637901L, 642076L, 652686L, 625713L, 586870L, 612790L, 644259L, 662727L, 602053L, 660618L, 632131L, 614682L, 653821L, 610465L, 609168L, 626915L, 647457L, 648359L, 634158L, 632849L, 600430L, 615204L, 694460L, 649756L, 591166L, 629814L, 630437L, 625978L, 615904L, 656624L, 631511L, 625009L, 611946L, 556178L, 667084L, 731296L, 682332L, 630610L, 611882L, 579314L, 603953L, 610587L, 582812L, 629417L, 599818L, 616534L, 598594L, 612506L, 620976L, 541004L, 561542L, 524206L, 569205L, 562289L, 580409L, 577028L, 575408L, 560199L, 596401L, 555281L, 600934L, 610299L, 593279L, 587655L, 572755L, 569536L, 589294L, 564426L, 607583L, 620892L, 623576L, 606872L, 644750L, 614959L, 581822L, 671647L, 697624L, 628047L, 615181L, 600600L, 619522L, 610934L, 614369L, 640538L, 624088L, 636158L, 639664L, 668837L, 622135L, 636892L, 642949L, 637222L, 610105L, 679793L, 677803L, 733868L, 708628L, 692879L, 633134L, 666470L, 656872L, 655276L, 623001L, 664106L, 684280L, 660555L, 606026L, 693052L, 596881L, 643920L, 636678L, 629032L, 639576L, 622157L, 590728L, 566795L, 614961L, 592488L, 610259L, 580310L, 606235L, 640602L, 635451L, 673361L, 632792L, 636043L, 613121L, 617556L, 578596L, 625075L, 634822L, 562186L, 641989L, 553326L, 557279L, 608600L, 617459L, 620441L, 641918L, 624130L, 645751L, 686138L, 608848L, 681818L, 628293L, 646106L, 648115L, 611431L, 656515L, 712557L, 619688L, 593253L, 654762L, 586499L, 608908L, 592633L, 622272L, 624534L, 633929L, 613364L, 608531L, 605102L, 577586L, 566443L, 565010L, 553751L, 553566L, 574706L, 619212L, 587692L, 593626L, 595435L, 568903L, 546904L, 585700L, 587351L, 641639L, 633931L, 639225L, 631794L, 648785L, 613912L, 640281L, 633749L, 606401L, 603209L, 557561L, 631952L, 601439L, 674419L, 629303L, 570282L, 575091L, 636764L, 623242L, 605736L, 554116L, 641358L, 582620L, 573743L, 640920L, 609148L, 614495L, 657975L, 619764L, 616387L, 607586L, 633314L, 623530L, 606831L, 638162L, 662410L, 628567L, 683170L, 620018L, 737068L, 662926L, 653855L, 633676L, 604093L, 589845L, 577096L, 599242L, 567483L, 597533L, 606206L, 626904L, 626289L, 661580L, 649123L, 632241L, 643789L, 617118L, 711156L, 655943L, 633489L, 668458L, 597369L, 639116L, 638759L, 612941L, 633501L, 647076L, 667423L, 658704L, 694909L, 651595L, 622831L, 615662L, 619845L, 582239L, 578870L, 580963L, 585970L, 593784L, 570602L, 581912L, 586175L, 620224L, 601631L, 566505L, 610508L, 633092L, 603754L, 667835L, 632413L, 663447L, 562683L, 674393L, 622422L, 596417L, 604454L, 612692L, 689189L, 662086L, 713250L, 687867L, 646231L, 619167L, 587609L, 579941L, 600092L, 647640L, 625013L, 531959L, 539778L, 568148L, 574573L, 585963L, 602894L, 630743L, 589095L, 601516L, 617502L, 632532L, 622186L, 593941L, 608553L, 614847L, 596658L, 651010L, 610202L, 600938L, 609463L, 670619L, 590285L, 572482L, 555175L, 567303L, 587337L, 624879L, 602056L, 604199L, 626948L, 622025L, 611887L, 562938L, 565700L, 621840L, 668573L, 648568L, 613116L, 602621L, 608055L, 617462L, 634706L, 664698L, 629686L, 582920L, 567358L, 542274L, 540740L, 552058L, 615433L, 613119L, 591429L, 626937L, 592218L, 614510L, 554047L, 612712L, 590889L, 631071L, 591834L, 621865L, 603086L, 623765L, 567000L, 581477L, 628195L, 565883L, 628504L, 649041L, 602302L, 502293L, 538842L, 561813L, 569297L, 560856L, 588711L, 585926L, 599429L, 609856L, 643223L, 644887L, 622571L, 636611L, 693594L, 609298L, 565625L, 676708L, 568847L, 568746L, 573431L, 569915L, 563081L, 542803L, 562321L, 554114L, 593377L, 617787L, 657086L, 583922L, 572218L, 612420L, 647891L, 655620L, 621775L, 664348L, 610196L, 639539L, 609849L, 657711L, 601915L, 608140L, 586703L, 638228L, 633152L, 628343L, 660803L, 636188L, 640767L, 658471L, 633565L, 625712L, 648879L, 664188L, 629003L, 632793L, 555382L, 528806L, 622592L, 606565L, 581966L, 555663L, 555797L, 568151L, 578985L, 572257L, 616808L, 563889L, 600036L, 649669L, 604802L, 606414L, 669856L, 668256L, 629574L, 633584L, 621747L, 560243L, 636940L, 611774L, 594045L, 687513L, 680729L, 645860L, 641295L, 604390L, 622294L, 632100L, 727853L, 674755L, 661871L, 618534L, 612213L, 642591L, 611987L, 569601L, 567212L, 611270L, 557751L, 527818L, 520947L, 594961L, 551645L, 634137L, 619003L, 583102L, 610843L, 633118L, 585226L, 567324L, 581845L, 583048L, 567316L, 587568L, 588466L, 537661L, 615813L, 636742L, 638393L, 650200L, 656268L, 622602L, 611714L, 634179L, 581699L, 633613L, 539385L, 536783L, 565916L, 618206L, 606880L, 660847L, 578982L, 629856L, 599015L, 643385L, 649429L, 613876L, 584416L, 607362L, 662095L, 643973L), `1996` = c(737990L, 812895L, 803228L, 709318L, 684966L, 717900L, 791050L, 833279L, 751276L, 791902L, 751376L, 753282L, 743829L, 717294L, 717712L, 744534L, 756208L, 768089L, 678170L, 653893L, 729682L, 701821L, 700127L, 733116L, 745857L, 736084L, 766212L, 692074L, 741083L, 741389L, 758470L, 736073L, 724640L, 741325L, 673861L, 719266L, 724278L, 766421L, 703479L, 733841L, 736589L, 787111L, 678597L, 720100L, 774550L, 724714L, 668788L, 696131L, 719498L, 738631L, 748810L, 692766L, 738278L, 690143L, 723233L, 721562L, 708378L, 737096L, 794118L, 746431L, 743635L, 769857L, 718884L, 787125L, 741231L, 774181L, 774289L, 771990L, 771758L, 797659L, 792835L, 836020L, 829029L, 756832L, 700400L, 770686L, 764069L, 740080L, 736654L, 715267L, 709470L, 691172L, 700557L, 646104L, 688530L, 707423L, 710363L, 682215L, 753976L, 782791L, 742150L, 716347L, 789024L, 760092L, 709306L, 761841L, 757917L, 817626L, 767372L, 722401L, 779251L, 768083L, 747438L, 740846L, 771368L, 731826L, 722556L, 807060L, 841763L, 764135L, 749435L, 788437L, 769316L, 668779L, 755800L, 809375L, 772220L, 761138L, 722728L, 703023L, 681185L, 715067L, 704726L, 716822L, 785534L, 806315L, 769143L, 740618L, 751090L, 788063L, 768468L, 760331L, 742641L, 715393L, 758937L, 754094L, 740947L, 700234L, 700447L, 727463L, 723228L, 739911L, 743649L, 766393L, 755761L, 708455L, 697191L, 693032L, 698873L, 735718L, 722659L, 716657L, 794653L, 773518L, 774463L, 796658L, 761761L, 736104L, 761563L, 814991L, 749239L, 733354L, 796384L, 776828L, 774447L, 723709L, 732756L, 689107L, 759291L, 797684L, 768320L, 728140L, 728982L, 760471L, 761414L, 773105L, 706135L, 782683L, 749935L, 753380L, 731698L, 740616L, 743408L, 824850L, 790103L, 751754L, 812869L, 832912L, 763088L, 817337L, 773420L, 754143L, 750387L, 766993L, 768660L, 728988L, 770750L, 749936L, 755715L, 738084L, 722376L, 708293L, 734445L, 728569L, 696452L, 802488L, 759783L, 795663L, 761693L, 786028L, 784111L, 721861L, 794919L, 751992L, 800153L, 812005L, 755174L, 731524L, 726107L, 715393L, 666327L, 688379L, 705801L, 772680L, 741238L, 725715L, 780880L, 779334L, 756271L, 784915L, 758348L, 785987L, 767503L, 715681L, 746351L, 760858L, 727297L, 706176L, 725730L, 742982L, 735601L, 703927L, 772908L, 723844L, 770696L, 690787L, 709557L, 735066L, 705005L, 742566L, 746975L, 760692L, 765569L, 700376L, 714739L, 724075L, 778830L, 782911L, 706621L, 717964L, 752721L, 731217L, 732343L, 744544L, 789331L, 751413L, 710611L, 699139L, 734719L, 711398L, 743411L, 692253L, 765767L, 725239L, 732536L, 758095L, 746484L, 770738L, 701230L, 738849L, 729988L, 733402L, 763133L, 767406L, 769772L, 733562L, 691056L, 730727L, 737687L, 764584L, 731662L, 794181L, 656325L, 781813L, 760392L, 731556L, 802638L, 740376L, 759533L, 743059L, 796081L, 802181L, 719332L, 775336L, 761971L, 702191L, 721686L, 696337L, 744524L, 765207L, 753387L, 786907L, 692457L, 776402L, 753516L, 691262L, 718039L, 707544L, 705568L, 716318L, 718145L, 801731L, 813708L, 727802L, 784803L, 796587L, 775825L, 757633L, 778035L, 741768L, 777374L, 772380L, 731304L, 731662L, 749089L, 747946L, 731528L, 746885L, 688554L, 675904L, 667706L, 689077L, 700313L, 714372L, 701012L, 770249L, 775784L, 796486L, 753032L, 795448L, 742590L, 706158L, 727721L, 713647L, 717234L, 699484L, 719942L, 705293L, 716231L, 741609L, 738922L, 734760L, 709776L, 708549L, 716722L, 690327L, 698911L, 692147L, 744907L, 735519L, 777673L, 790560L, 785992L, 730185L, 739351L, 723250L, 742489L, 755901L, 727531L, 726175L, 696877L, 740153L, 734623L, 788312L, 750443L, 766021L, 729676L, 773387L, 760213L, 763046L, 772226L, 694438L, 676034L, 687654L, 727042L, 729904L, 789436L, 795153L, 728651L, 737321L, 761991L, 711070L, 687486L, 762805L, 729442L, 730578L, 746082L, 772251L, 756972L, 692740L, 680961L, 727791L, 701902L, 676860L, 747041L, 734457L, 737447L, 705809L, 719569L, 717107L, 691018L, 717359L, 710236L, 717783L, 692818L, 716822L, 750789L, 733720L, 710738L, 709547L, 711408L, 712173L, 761482L, 745188L, 781585L, 831635L, 747470L, 797020L, 796325L, 754762L, 814327L, 776045L, 761759L, 774129L, 747058L, 739722L, 767341L, 772010L, 810510L, 793132L, 738721L, 719525L, 724664L, 737536L, 752392L, 693255L, 653700L, 741462L, 727110L, 735655L, 710937L, 787716L, 794695L, 830699L, 788474L, 767706L, 805942L, 763131L, 751630L, 735787L, 785435L, 744787L, 720687L, 790002L, 790709L, 750438L, 770960L, 735548L, 764649L, 796389L, 703422L, 713573L, 787505L, 764095L, 745043L, 677835L, 720384L, 767330L, 707066L, 700021L, 729484L, 682714L, 678866L, 660153L, 624084L, 614234L, 677316L, 716930L, 692525L, 714592L, 671452L, 668284L, 758296L, 778721L, 728094L, 756457L, 748504L, 770011L, 729570L, 714463L, 748421L, 786879L, 778653L, 734675L, 780630L, 730376L, 725349L, 776427L, 738673L, 731489L, 750572L, 759800L, 753301L, 740916L, 742844L, 711966L, 731806L, 808456L, 755243L, 690433L, 755254L, 770583L, 761479L, 754685L, 793479L, 797086L, 778053L, 753267L, 677977L, 774899L, 818296L, 810742L, 779727L, 749425L, 678491L, 717734L, 713144L, 685972L, 766420L, 736316L, 760980L, 746113L, 752702L, 775253L, 695952L, 704923L, 666676L, 669386L, 678146L, 696573L, 697497L, 695212L, 641289L, 697935L, 672335L, 697897L, 729797L, 701548L, 710556L, 707878L, 708348L, 716253L, 693888L, 712321L, 710751L, 725324L, 727862L, 807493L, 786052L, 731060L, 821748L, 843407L, 759228L, 742437L, 714784L, 746510L, 726962L, 737258L, 770426L, 772407L, 783260L, 785034L, 815108L, 749802L, 791309L, 810484L, 804161L, 772560L, 805685L, 783484L, 854057L, 809829L, 795432L, 765468L, 791198L, 802578L, 759020L, 757606L, 761882L, 786160L, 751727L, 691103L, 788325L, 690173L, 737175L, 722965L, 742021L, 731833L, 744361L, 717079L, 717228L, 729574L, 720160L, 736659L, 702207L, 725693L, 717068L, 685890L, 742223L, 697879L, 710868L, 689632L, 715988L, 702953L, 757518L, 776437L, 699680L, 790368L, 673352L, 717015L, 740663L, 738388L, 759489L, 758985L, 759201L, 799123L, 808231L, 737564L, 793457L, 761156L, 791104L, 783997L, 713063L, 754256L, 815789L, 746665L, 734757L, 795047L, 729853L, 727635L, 722717L, 738763L, 739091L, 736789L, 702909L, 706292L, 715912L, 701028L, 712356L, 687530L, 680020L, 678874L, 688712L, 724485L, 689868L, 749010L, 751105L, 701224L, 673639L, 701533L, 688502L, 742232L, 729765L, 738209L, 737057L, 740342L, 704465L, 752891L, 737692L, 747571L, 737052L, 708127L, 770064L, 727526L, 806795L, 747954L, 725113L, 714045L, 797391L, 753664L, 737361L, 695441L, 785351L, 714253L, 704387L, 751058L, 737720L, 710857L, 779208L, 746705L, 743600L, 725824L, 757222L, 754839L, 726475L, 747107L, 780202L, 742756L, 805124L, 717914L, 840995L, 763950L, 757985L, 742415L, 713906L, 724632L, 731652L, 750302L, 733748L, 734093L, 739627L, 766319L, 743504L, 808187L, 800526L, 770858L, 770029L, 705900L, 808436L, 741475L, 742446L, 787538L, 716027L, 748842L, 732054L, 697447L, 718886L, 754285L, 761323L, 738410L, 777293L, 741622L, 702990L, 725412L, 737172L, 690382L, 701756L, 719585L, 710289L, 715586L, 711931L, 720305L, 709062L, 726655L, 709779L, 700180L, 721640L, 731277L, 698987L, 786364L, 758996L, 798831L, 719516L, 791456L, 760234L, 731086L, 762433L, 742844L, 765854L, 765905L, 842840L, 835616L, 773339L, 769918L, 718215L, 705940L, 736056L, 759568L, 718120L, 656001L, 703857L, 729491L, 734024L, 740269L, 746041L, 746451L, 733962L, 752207L, 780224L, 778574L, 757774L, 734215L, 729248L, 722058L, 726873L, 766260L, 723676L, 703470L, 715126L, 755355L, 704977L, 677354L, 667533L, 687073L, 720729L, 746976L, 736198L, 722909L, 723800L, 708904L, 683307L, 658102L, 689277L, 750519L, 799494L, 769133L, 752127L, 743095L, 748328L, 768048L, 772484L, 809811L, 799244L, 747764L, 703544L, 713442L, 713724L, 732585L, 784987L, 774182L, 762618L, 797893L, 754778L, 773043L, 710524L, 773099L, 705499L, 781775L, 705662L, 743124L, 716737L, 740180L, 699565L, 716836L, 764705L, 668630L, 741762L, 772708L, 736340L, 627323L, 672944L, 687947L, 664084L, 696297L, 741575L, 715341L, 719115L, 728418L, 767592L, 756665L, 733613L, 749315L, 813891L, 716175L, 652591L, 770332L, 697437L, 714879L, 705493L, 723083L, 708219L, 687598L, 698087L, 690733L, 708800L, 737942L, 767878L, 701165L, 688490L, 727757L, 773873L, 776808L, 750638L, 782259L, 745545L, 771962L, 733103L, 796061L, 731844L, 725008L, 703237L, 766407L, 758373L, 756717L, 775912L, 761212L, 781087L, 797970L, 784017L, 801787L, 825046L, 843417L, 780468L, 790640L, 722899L, 693788L, 779241L, 794382L, 753552L, 713889L, 720812L, 711706L, 686444L, 708337L, 736795L, 688019L, 703427L, 747321L, 720037L, 700686L, 773218L, 779320L, 764839L, 786828L, 793293L, 723815L, 789556L, 760236L, 747074L, 832571L, 795567L, 744870L, 737038L, 726864L, 722826L, 722944L, 831673L, 772599L, 738557L, 703818L, 731413L, 768422L, 726363L, 701620L, 684037L, 746942L, 673737L, 667924L, 668671L, 731640L, 703209L, 749753L, 726158L, 702226L, 725625L, 763124L, 712928L, 703459L, 709214L, 705959L, 691700L, 717243L, 712175L, 675441L, 758252L, 759499L, 793851L, 802496L, 795481L, 754583L, 735646L, 758179L, 732044L, 799247L, 698577L, 698508L, 706488L, 763093L, 753311L, 791443L, 744734L, 803928L, 735191L, 764650L, 762530L, 721054L, 710977L, 715105L, 767235L, 780751L), `1997` = c(906160, 949513, 960886, 850012, 865160, 891667, 980184, 994245, 899510, 928091, 891875, 882930, 882117, 882405, 880961, 889327, 887647, 918808, 840024, 878470, 927868, 910088, 882857, 911685, 940536, 897901, 932932, 884386, 947801, 923113, 917075, 897786, 899566, 912473, 854498, 886240, 907838, 929573, 878109, 886025, 886313, 998585, 879056, 924375, 948762, 939317, 857830, 919717, 903673, 928149, 947499, 837884, 890183, 846600, 877794, 886679, 864297, 918659, 993645, 926808, 922614, 963482, 920125, 973530, 924204, 969219, 940076, 898570, 913137, 929727, 967683, 1014470, 981476, 960234, 947641, 981524, 942489, 934612, 938742, 922988, 899181, 858844, 887868, 854025, 931679, 909551, 884805, 828635, 908533, 949735, 920006, 906982, 961195, 927803, 898805, 947165, 950153, 1007140, 976464, 899876, 958194, 916916, 906876, 909506, 981513, 941589, 902840, 946221, 1010820, 967643, 934044, 962156, 971747, 840435, 956969, 1011700, 998061, 1005640, 911335, 903444, 859727, 879086, 889882, 883694, 955819, 971570, 937503, 907016, 949796, 942408, 939141, 913372, 913488, 899686, 914640, 930508, 917733, 870475, 876421, 890770, 896927, 903919, 914803, 923425, 914772, 917408, 939572, 918213, 923563, 908341, 928267, 875871, 945400, 913698, 948107, 959693, 925071, 925773, 916966, 974467, 907180, 912424, 982961, 946834, 931902, 904568, 907028, 845014, 925630, 977668, 939050, 928704, 934262, 932324, 926731, 946256, 894657, 965268, 927777, 943627, 905525, 945394, 921450, 1006390, 941520, 892439, 967116, 960164, 903086, 966384, 938554, 939912, 927817, 939745, 954268, 919440, 938461, 912945, 949255, 910993, 921894, 926785, 947310, 936831, 901592, 1011140, 963034, 1002540, 941225, 966669, 963522, 889071, 933124, 887296, 937309, 959010, 926524, 917059, 938680, 925740, 849931, 877912, 890265, 978733, 939650, 926787, 940752, 915192, 888022, 924202, 875756, 905285, 900964, 861556, 911341, 932823, 877248, 875533, 892734, 953180, 935343, 892380, 981472, 910907, 934561, 855711, 884253, 884706, 882218, 887446, 891352, 899581, 928913, 852866, 856012, 857699, 898257, 877175, 820495, 862109, 892660, 878077, 879207, 909951, 966575, 924204, 880948, 857374, 889496, 860390, 898785, 870470, 932971, 886078, 900146, 933096, 912417, 942572, 861612, 908290, 899299, 885850, 948900, 934620, 941542, 941798, 889390, 921718, 957078, 945169, 936077, 999350, 867091, 949612, 936434, 908368, 985661, 918120, 948579, 897708, 950105, 976893, 896984, 958005, 935290, 892519, 860610, 850048, 901602, 943845, 912435, 951981, 878831, 959824, 941001, 888120, 927532, 922571, 927303, 916800, 887480, 964340, 999190, 923405, 1004930, 970716, 933250, 952232, 963109, 910133, 936912, 938784, 901736, 907701, 913389, 921723, 946479, 952472, 893781, 873479, 882914, 909443, 916413, 926057, 895540, 953355, 941762, 960739, 914958, 983087, 942265, 907741, 916269, 882871, 918222, 926042, 906497, 890400, 935990, 957544, 958525, 921364, 900515, 903776, 887992, 855662, 843684, 821008, 882123, 872045, 910349, 921416, 935880, 873281, 880722, 878376, 907666, 907831, 892697, 874901, 849622, 901710, 928404, 995760, 966842, 917522, 874767, 941428, 927303, 962140, 956279, 881487, 901881, 893190, 921994, 912272, 957265, 924446, 858762, 893827, 911015, 889549, 854092, 955572, 907834, 918567, 923414, 953349, 940800, 877238, 895815, 930107, 933209, 931280, 970708, 929684, 923777, 893084, 913527, 899698, 866638, 895777, 881743, 881503, 865346, 900480, 929339, 940491, 902127, 876332, 864020, 865402, 933757, 959449, 963016, 1021350, 924307, 978949, 958352, 916168, 975048, 951512, 943147, 976807, 943929, 907016, 915865, 913830, 974687, 951557, 895502, 902135, 908849, 953548, 974255, 916417, 852230, 934629, 891019, 883257, 843200, 947810, 941935, 987893, 940630, 931916, 957953, 946657, 946086, 912321, 936289, 895921, 898872, 945933, 934482, 877989, 890457, 865197, 889771, 943184, 871159, 933572, 992150, 942919, 958225, 906193, 947764, 950290, 900887, 884223, 909641, 876817, 881762, 859357, 836939, 827908, 852835, 906173, 897169, 928963, 867804, 856881, 946909, 934019, 867247, 915214, 906786, 959374, 927604, 898369, 937864, 941288, 954522, 921343, 941711, 910778, 907075, 956240, 907092, 915883, 944873, 936505, 920198, 906106, 914565, 874856, 875426, 952440, 900291, 842417, 890282, 921299, 902558, 911846, 974858, 979239, 936239, 940743, 876229, 946729, 971026, 965545, 940795, 926441, 852638, 909014, 881349, 852582, 926860, 890187, 911825, 925100, 920028, 951748, 908720, 956095, 910242, 906122, 914866, 944345, 923009, 902415, 828112, 892218, 844817, 866300, 899457, 879018, 905592, 877280, 872737, 882418, 866054, 882706, 866905, 845415, 868128, 960505, 972870, 918582, 999874, 1032710, 938650, 901828, 877555, 908310, 882176, 908778, 943986, 925066, 924616, 933891, 950102, 866820, 919902, 972197, 945373, 936292, 962233, 930773, 1024160, 979245, 934156, 924456, 949994, 996201, 901686, 913541, 934133, 936965, 938810, 875844, 963737, 887294, 908757, 877095, 902071, 901017, 924491, 914452, 907791, 926822, 864492, 888707, 885014, 906319, 895890, 870364, 909084, 880626, 896020, 895233, 918976, 907468, 949563, 953514, 889887, 966046, 858955, 897174, 908151, 909576, 940457, 948673, 957497, 1006620, 1001310, 925156, 970096, 917345, 970891, 988343, 922494, 928707, 982292, 945007, 919422, 979885, 910601, 899534, 904809, 924747, 938824, 915096, 859491, 878912, 899486, 850485, 906255, 884130, 875048, 872564, 869409, 910849, 847858, 914893, 935817, 894357, 852575, 897177, 890205, 941006, 899504, 896807, 919267, 908265, 882396, 921814, 905894, 914327, 913555, 881486, 961882, 918864, 998046, 927263, 961299, 947133, 988376, 948394, 929528, 858503, 951066, 885661, 846655, 925547, 898992, 889690, 912179, 890516, 900274, 898205, 926326, 926245, 891357, 929073, 970723, 925632, 976600, 860795, 995345, 927315, 921519, 910045, 878095, 893219, 870755, 885965, 876223, 859490, 869139, 900932, 878864, 956177, 966240, 927501, 900552, 859318, 942213, 913031, 902956, 962926, 868469, 903273, 882407, 825811, 873200, 933978, 931506, 891656, 918743, 900800, 867014, 909039, 929153, 867089, 880499, 868382, 892943, 929053, 889542, 893053, 903034, 921410, 870024, 854144, 890288, 903492, 870737, 964380, 926074, 998487, 875131, 984487, 921724, 920996, 918888, 855398, 892012, 892870, 962983, 982248, 937075, 935084, 882440, 879355, 895255, 901194, 876275, 799802, 859251, 900789, 914223, 927575, 914642, 921458, 892476, 890406, 945783, 948923, 940924, 928941, 935917, 895308, 899973, 945347, 929206, 891973, 895022, 895010, 867263, 830280, 857586, 893413, 926041, 931043, 907539, 914797, 913772, 900117, 832395, 854843, 862390, 928274, 972422, 918892, 905629, 942681, 935521, 965510, 935863, 952270, 961232, 917588, 865348, 910505, 894154, 906260, 934292, 912458, 898609, 936832, 902607, 921803, 885667, 953713, 903271, 946914, 857538, 904623, 896379, 913682, 876445, 889918, 923843, 825321, 901597, 918506, 908751, 802357, 856764, 909221, 853586, 860699, 914166, 896609, 902269, 910430, 942056, 934562, 911441, 952404, 1017570, 884856, 817354, 947768, 876781, 869252, 886942, 891439, 907738, 904217, 918025, 911230, 952842, 956237, 965178, 896086, 877372, 880560, 945503, 906576, 908558, 941236, 896898, 898426, 886460, 962481, 899112, 928437, 891470, 935848, 908850, 937067, 974627, 938856, 976633, 972051, 934038, 958209, 1009530, 1019220, 957532, 978087, 951631, 923925, 976398, 967013, 924285, 878774, 905158, 912152, 843485, 856489, 913540, 879780, 854328, 894976, 882689, 868866, 958845, 927644, 916655, 933483, 939399, 872923, 963778, 919749, 891003, 1004150, 958020, 888590, 889316, 883677, 871267, 879367, 989666, 923075, 924628, 865533, 926794, 954405, 909027, 876608, 890353, 914586, 847214, 837879, 829823, 892389, 873630, 938985, 905720, 875648, 941523, 970001, 898526, 902342, 906479, 905716, 893599, 912509, 900888, 896592, 963477, 954971, 965052, 974969, 969205, 918389, 901243, 936851, 914725, 1006250, 889501, 866121, 877554, 934950, 940941, 965553, 898325, 966638, 897992, 942995, 960006, 922263, 893339, 922690, 927580, 925546), `1998` = c(828555L, 867350L, 873249L, 794997L, 788981L, 792371L, 887323L, 917714L, 808591L, 840897L, 802737L, 805937L, 815040L, 827527L, 841649L, 843361L, 798750L, 834777L, 745107L, 781758L, 841456L, 818363L, 795354L, 830186L, 880578L, 802430L, 842663L, 795743L, 871326L, 833992L, 824811L, 794762L, 800032L, 808501L, 778498L, 819039L, 831826L, 852257L, 795292L, 791819L, 792732L, 908135L, 792237L, 829744L, 875020L, 864403L, 778413L, 852846L, 836149L, 876411L, 894488L, 797885L, 845428L, 798999L, 812634L, 802753L, 787609L, 856106L, 919594L, 859241L, 861373L, 888037L, 839443L, 899896L, 838894L, 886110L, 873928L, 801135L, 818226L, 827876L, 875274L, 921657L, 890019L, 868927L, 888402L, 925137L, 886210L, 860988L, 867024L, 860726L, 823020L, 787693L, 837727L, 784183L, 876646L, 826784L, 812756L, 762857L, 836396L, 880860L, 846462L, 833516L, 874862L, 831906L, 818589L, 852874L, 856236L, 925567L, 891149L, 807151L, 865566L, 811789L, 802860L, 822882L, 917291L, 859535L, 820365L, 882415L, 930390L, 908341L, 861131L, 909106L, 922738L, 793045L, 898450L, 944211L, 945926L, 936539L, 835470L, 827881L, 793997L, 814733L, 810984L, 799810L, 857523L, 913202L, 903218L, 856011L, 882467L, 860618L, 850431L, 804832L, 835519L, 842851L, 835569L, 888815L, 864975L, 806477L, 821638L, 828004L, 816241L, 812399L, 809693L, 821930L, 825401L, 816297L, 849785L, 847143L, 840906L, 820656L, 854056L, 790463L, 876370L, 846083L, 890359L, 892336L, 859427L, 851044L, 855835L, 909254L, 823000L, 829333L, 902900L, 883475L, 870656L, 811817L, 807690L, 766328L, 846433L, 878424L, 844437L, 864465L, 848595L, 853820L, 868506L, 880423L, 819152L, 896569L, 858262L, 870579L, 850487L, 872961L, 850120L, 928003L, 873108L, 814606L, 882531L, 885315L, 828351L, 888398L, 848983L, 852130L, 844159L, 864538L, 878173L, 833896L, 875099L, 859302L, 875337L, 827792L, 843212L, 843512L, 854178L, 854556L, 807164L, 923134L, 888129L, 904208L, 859273L, 884630L, 890178L, 826033L, 863021L, 808339L, 829961L, 861125L, 855120L, 859986L, 871929L, 862765L, 771498L, 798480L, 822352L, 925221L, 863923L, 862384L, 888190L, 872692L, 831745L, 860884L, 808750L, 827645L, 828036L, 798314L, 832054L, 867869L, 819446L, 795392L, 811607L, 889770L, 844836L, 803592L, 909923L, 819911L, 856256L, 769779L, 813649L, 840820L, 826185L, 821333L, 789616L, 814084L, 837800L, 767903L, 776838L, 780570L, 840155L, 806822L, 755237L, 781951L, 806615L, 778978L, 788720L, 839015L, 900374L, 835934L, 826803L, 790756L, 816271L, 782888L, 818475L, 788145L, 849534L, 792132L, 812110L, 856505L, 836204L, 880209L, 782219L, 838821L, 830997L, 812372L, 874472L, 860887L, 865500L, 854090L, 804678L, 838784L, 879362L, 877216L, 886201L, 964407L, 817069L, 872333L, 853024L, 831673L, 890513L, 833002L, 885259L, 816930L, 863662L, 883611L, 785949L, 854972L, 848632L, 816680L, 797381L, 782746L, 803774L, 865250L, 846156L, 871942L, 789809L, 890546L, 871730L, 825676L, 855239L, 864187L, 876535L, 876509L, 831339L, 902748L, 921894L, 846879L, 937666L, 916609L, 839047L, 864885L, 867943L, 802213L, 850906L, 860311L, 811859L, 827506L, 851678L, 868182L, 898017L, 891260L, 834210L, 795546L, 791968L, 830990L, 844678L, 858425L, 818220L, 862982L, 873871L, 891682L, 830363L, 886798L, 850652L, 806439L, 819150L, 772727L, 833177L, 840839L, 826955L, 802278L, 839804L, 865715L, 872084L, 837833L, 821961L, 818050L, 801948L, 779634L, 757246L, 717964L, 781732L, 778045L, 836338L, 843685L, 848558L, 780808L, 777484L, 779081L, 797735L, 805682L, 803675L, 787307L, 772787L, 820716L, 833981L, 910341L, 883968L, 815053L, 795038L, 878060L, 843143L, 862841L, 858820L, 789826L, 825188L, 824036L, 844321L, 816772L, 847455L, 820368L, 747689L, 798132L, 825787L, 806814L, 748369L, 867695L, 818588L, 834612L, 845678L, 854393L, 833553L, 761783L, 801271L, 841744L, 846174L, 851494L, 889433L, 869581L, 823114L, 804714L, 825701L, 835258L, 813403L, 854144L, 840389L, 823779L, 803179L, 834584L, 865288L, 890330L, 844470L, 800872L, 779198L, 804813L, 855014L, 875539L, 872130L, 961665L, 829817L, 873479L, 843738L, 816736L, 873927L, 852089L, 854232L, 885752L, 855690L, 809685L, 805519L, 803446L, 866279L, 840114L, 790286L, 811412L, 823642L, 878471L, 912221L, 840971L, 776630L, 869816L, 810220L, 826710L, 747174L, 856543L, 840960L, 877086L, 834824L, 831245L, 890869L, 892423L, 891600L, 844160L, 858115L, 819014L, 823470L, 862005L, 861335L, 791286L, 804432L, 776411L, 805653L, 860550L, 799361L, 851338L, 909472L, 852156L, 858716L, 818782L, 880341L, 882005L, 821603L, 807299L, 832008L, 824045L, 826798L, 796461L, 777255L, 761859L, 785801L, 844661L, 825378L, 850416L, 777600L, 765844L, 876580L, 847660L, 768696L, 828511L, 814216L, 859915L, 850766L, 812974L, 865383L, 860291L, 884493L, 828217L, 869480L, 842393L, 851547L, 883769L, 826486L, 859509L, 867244L, 853930L, 850386L, 829023L, 838318L, 827949L, 828259L, 900995L, 848265L, 774375L, 833993L, 861317L, 823633L, 828532L, 903015L, 930343L, 882460L, 887903L, 796928L, 900155L, 908580L, 900558L, 878173L, 845623L, 807353L, 838945L, 818937L, 789168L, 864926L, 822114L, 835909L, 837454L, 829351L, 851515L, 814665L, 880850L, 828522L, 822658L, 846650L, 887175L, 856052L, 837136L, 764743L, 832172L, 762300L, 779993L, 798378L, 783180L, 811305L, 787878L, 788217L, 789272L, 789212L, 798412L, 785975L, 768747L, 782923L, 893930L, 901416L, 824430L, 931649L, 953468L, 871811L, 831330L, 813453L, 838543L, 806853L, 852575L, 877424L, 847115L, 869629L, 877576L, 892614L, 784811L, 831941L, 877794L, 859086L, 844220L, 882423L, 849162L, 949544L, 903854L, 851492L, 851016L, 877635L, 920602L, 840932L, 838266L, 880762L, 872700L, 880149L, 803699L, 887053L, 803416L, 849137L, 816248L, 824209L, 815911L, 840874L, 832274L, 805500L, 825782L, 760796L, 817566L, 815067L, 830688L, 829029L, 791685L, 827017L, 815898L, 853250L, 843606L, 854818L, 835600L, 896995L, 875641L, 842649L, 916025L, 792404L, 833443L, 836717L, 838991L, 861761L, 878378L, 883748L, 928028L, 933810L, 833596L, 878438L, 815300L, 870009L, 899122L, 833208L, 856872L, 922982L, 873710L, 835894L, 903231L, 832269L, 842382L, 814854L, 828630L, 851983L, 848645L, 815240L, 818892L, 821480L, 775147L, 833925L, 803720L, 788196L, 788954L, 781896L, 816726L, 759151L, 828326L, 874041L, 825750L, 768786L, 810661L, 816681L, 870692L, 828914L, 829244L, 843287L, 816841L, 786248L, 825920L, 803776L, 824863L, 834541L, 817536L, 909834L, 855017L, 926171L, 861344L, 865363L, 861292L, 905154L, 882988L, 858862L, 796945L, 885770L, 821335L, 779519L, 867420L, 797926L, 807724L, 821380L, 818866L, 809246L, 788030L, 834360L, 836928L, 809686L, 852897L, 919798L, 858332L, 897502L, 791422L, 926247L, 859952L, 855284L, 832858L, 802729L, 843122L, 823616L, 830165L, 817461L, 802260L, 804830L, 814533L, 787867L, 881802L, 900167L, 868107L, 827553L, 795830L, 879847L, 829789L, 834921L, 882103L, 799060L, 828849L, 789892L, 746864L, 803369L, 846088L, 870770L, 834064L, 858388L, 840750L, 807310L, 852879L, 867048L, 782492L, 796095L, 794402L, 802549L, 849538L, 837123L, 811780L, 824832L, 828604L, 769295L, 764548L, 805671L, 815635L, 793193L, 893307L, 843281L, 921563L, 810182L, 912642L, 835403L, 828614L, 823642L, 769967L, 795571L, 800913L, 877993L, 883778L, 848123L, 837751L, 780819L, 775595L, 816416L, 817818L, 820052L, 741939L, 793611L, 831411L, 836398L, 870623L, 859439L, 846200L, 828476L, 832243L, 876636L, 881383L, 869615L, 847133L, 892447L, 836168L, 838477L, 897764L, 865242L, 835380L, 847599L, 804247L, 788005L, 773587L, 804191L, 863656L, 853588L, 850028L, 822317L, 823413L, 827279L, 813192L, 779056L, 800078L, 784177L, 849302L, 892897L, 825585L, 829160L, 886824L, 883173L, 894598L, 852733L, 854756L, 862806L, 828660L, 782598L, 832927L, 807515L, 831118L, 852432L, 827904L, 816285L, 837204L, 797192L, 813616L, 775385L, 860141L, 805399L, 857640L, 761059L, 825023L, 818079L, 845440L, 804416L, 807871L, 846623L, 747814L, 817944L, 832044L, 832910L, 723565L, 778558L, 839079L, 783331L, 794834L, 837308L, 810970L, 842559L, 861019L, 878191L, 860546L, 826338L, 857779L, 934410L, 794275L, 731707L, 877647L, 814525L, 809920L, 837032L, 831485L, 831115L, 818830L, 843329L, 818818L, 871156L, 873419L, 880671L, 811264L, 797083L, 790747L, 851979L, 818016L, 831662L, 852349L, 804033L, 803145L, 786247L, 860839L, 795910L, 822010L, 789591L, 834299L, 802108L, 832877L, 877474L, 833860L, 867767L, 863880L, 821284L, 858271L, 931551L, 948445L, 901409L, 922373L, 896791L, 856953L, 919802L, 916720L, 877403L, 829908L, 849162L, 833900L, 768249L, 780771L, 841389L, 825546L, 801885L, 882678L, 829029L, 818576L, 906919L, 873642L, 841929L, 860188L, 861715L, 790616L, 887603L, 854544L, 814919L, 928184L, 872587L, 791991L, 806793L, 800254L, 798296L, 804740L, 923346L, 840914L, 852060L, 771300L, 827609L, 869403L, 838759L, 770951L, 790792L, 820932L, 761230L, 761243L, 751866L, 816921L, 778291L, 835260L, 815254L, 791154L, 861039L, 893872L, 829298L, 841222L, 838216L, 855151L, 834292L, 855123L, 838598L, 830432L, 916504L, 908291L, 926400L, 919217L, 920446L, 854540L, 830751L, 863459L, 835683L, 933347L, 805612L, 789369L, 810466L, 860929L, 871133L, 898502L, 814073L, 893476L, 816818L, 873364L, 900984L, 856223L, 823344L, 845817L, 847847L, 832718L), `1999` = c(817466L, 822745L, 819157L, 805801L, 796451L, 785995L, 880656L, 892468L, 790117L, 833717L, 800929L, 823888L, 782832L, 821916L, 853710L, 849825L, 805200L, 834506L, 737094L, 793421L, 823803L, 789255L, 795569L, 836376L, 901132L, 783869L, 810076L, 755919L, 839444L, 822805L, 822369L, 794873L, 797457L, 751425L, 752569L, 797679L, 811001L, 834370L, 784700L, 754835L, 771949L, 906268L, 780287L, 798663L, 860696L, 860293L, 779243L, 879368L, 832049L, 837296L, 844900L, 760638L, 821358L, 796651L, 820591L, 800522L, 779571L, 845495L, 892820L, 857997L, 876785L, 908799L, 855913L, 932897L, 889573L, 940839L, 899977L, 803187L, 838223L, 830042L, 860734L, 899570L, 876034L, 856779L, 879278L, 907299L, 853986L, 835392L, 815425L, 809588L, 809447L, 769000L, 871117L, 794254L, 900438L, 836821L, 802066L, 757051L, 833019L, 858099L, 807477L, 807580L, 868321L, 796027L, 775259L, 803746L, 833905L, 909254L, 887612L, 761705L, 823728L, 769458L, 772990L, 802883L, 917942L, 830936L, 781799L, 839423L, 888538L, 851267L, 804786L, 863749L, 874913L, 770914L, 899285L, 969316L, 971403L, 950551L, 834636L, 811503L, 780043L, 777131L, 742973L, 770063L, 827975L, 862785L, 850089L, 793426L, 841955L, 839751L, 861099L, 816581L, 843043L, 842870L, 828226L, 891820L, 871835L, 777392L, 813120L, 811254L, 820966L, 819176L, 806794L, 849012L, 809990L, 813028L, 853523L, 842200L, 817616L, 829678L, 891578L, 832295L, 879622L, 843686L, 874478L, 878924L, 856715L, 848707L, 840974L, 882337L, 795664L, 806677L, 942431L, 922202L, 919185L, 802925L, 824141L, 795445L, 875284L, 887994L, 833016L, 843472L, 806011L, 814177L, 822085L, 866495L, 795695L, 876189L, 832600L, 832360L, 825229L, 856661L, 833596L, 903413L, 866899L, 842620L, 896918L, 866043L, 794675L, 869040L, 824413L, 853468L, 824536L, 867855L, 899980L, 837507L, 891818L, 871498L, 872051L, 799333L, 831289L, 812314L, 822736L, 848116L, 786750L, 903114L, 869635L, 906358L, 845336L, 856249L, 871192L, 791061L, 833561L, 757643L, 808088L, 842856L, 851468L, 883145L, 862983L, 888536L, 788919L, 805526L, 841952L, 972447L, 890371L, 865265L, 886832L, 896688L, 861920L, 881235L, 831708L, 867960L, 829711L, 805086L, 858972L, 877606L, 836467L, 782661L, 773669L, 857699L, 794670L, 757352L, 882109L, 786671L, 850180L, 754708L, 793371L, 836036L, 799068L, 800423L, 767832L, 807983L, 830468L, 746039L, 775495L, 794662L, 824132L, 769614L, 722164L, 777096L, 794442L, 774975L, 742582L, 810646L, 894862L, 806510L, 828536L, 777363L, 817475L, 773217L, 822723L, 777244L, 830565L, 797223L, 818483L, 848676L, 815713L, 865914L, 744032L, 816089L, 771100L, 749175L, 856511L, 863205L, 838130L, 802734L, 794219L, 884791L, 863338L, 880383L, 890108L, 949470L, 799085L, 896638L, 879283L, 831889L, 906112L, 821268L, 848856L, 722524L, 801416L, 819484L, 720671L, 804937L, 821514L, 833717L, 818827L, 799486L, 813639L, 887455L, 837710L, 861528L, 774589L, 887336L, 876421L, 832819L, 842832L, 872169L, 897128L, 886015L, 834615L, 952765L, 975254L, 841009L, 920807L, 894593L, 809435L, 839233L, 826552L, 795874L, 855425L, 847293L, 790963L, 822984L, 848565L, 865199L, 911083L, 880805L, 809653L, 751219L, 772855L, 818818L, 841637L, 843120L, 798407L, 855846L, 878213L, 895660L, 818450L, 873372L, 863945L, 817162L, 851064L, 794288L, 869624L, 853478L, 839096L, 819827L, 849733L, 886826L, 899875L, 853697L, 826174L, 826313L, 795171L, 751596L, 753768L, 710024L, 762404L, 761295L, 829502L, 826345L, 844003L, 761952L, 753698L, 745282L, 763376L, 762427L, 774650L, 743522L, 765005L, 818128L, 801947L, 891859L, 871630L, 792358L, 774246L, 903079L, 885658L, 837674L, 838529L, 761572L, 791206L, 802170L, 807694L, 780869L, 809973L, 805961L, 747778L, 804973L, 811810L, 827156L, 746594L, 884131L, 806635L, 810719L, 822785L, 850893L, 860656L, 781086L, 806784L, 848593L, 842313L, 845116L, 860888L, 849938L, 816905L, 803360L, 811577L, 812527L, 794347L, 869719L, 858018L, 839195L, 805143L, 844978L, 869115L, 913573L, 878501L, 802152L, 804933L, 833554L, 864091L, 927957L, 901156L, 979139L, 829682L, 855858L, 829522L, 784665L, 865280L, 842557L, 842783L, 870459L, 866035L, 810546L, 812575L, 823051L, 909562L, 858101L, 771539L, 787704L, 812127L, 869660L, 914629L, 836849L, 777664L, 891312L, 806010L, 844510L, 763195L, 838758L, 806553L, 879549L, 829077L, 838765L, 892296L, 924979L, 923947L, 864330L, 847760L, 811817L, 793453L, 831193L, 839740L, 780529L, 789296L, 749683L, 786425L, 864232L, 814690L, 880440L, 930633L, 893004L, 901251L, 844780L, 914505L, 873075L, 832940L, 823989L, 832155L, 840761L, 837064L, 820151L, 814262L, 780218L, 817016L, 869107L, 813380L, 852837L, 796232L, 766351L, 890673L, 828894L, 739992L, 782203L, 774298L, 809855L, 803374L, 761051L, 813459L, 848909L, 867288L, 811804L, 856230L, 834648L, 852895L, 890351L, 835729L, 849257L, 835857L, 817460L, 822920L, 781368L, 811768L, 817988L, 823637L, 907225L, 838152L, 744061L, 809238L, 844597L, 787324L, 790089L, 884199L, 929816L, 885901L, 879326L, 775341L, 893172L, 874810L, 887255L, 871984L, 853616L, 834535L, 848509L, 813161L, 781259L, 872368L, 812551L, 815376L, 819059L, 819964L, 846184L, 811140L, 869797L, 821709L, 842377L, 872110L, 910859L, 863305L, 841551L, 782102L, 839191L, 754426L, 755274L, 787510L, 791636L, 836686L, 805622L, 779662L, 765943L, 776152L, 794017L, 805404L, 768341L, 771651L, 901155L, 914018L, 823916L, 937217L, 937061L, 848487L, 831773L, 800119L, 834739L, 813806L, 840077L, 881464L, 856587L, 904172L, 920602L, 899453L, 796174L, 824706L, 888210L, 875121L, 844981L, 863610L, 840164L, 965214L, 915794L, 840244L, 845475L, 880428L, 926829L, 830536L, 840893L, 908012L, 922721L, 902944L, 786077L, 872013L, 782278L, 835464L, 813254L, 827176L, 808397L, 818451L, 816272L, 809686L, 848443L, 762630L, 791244L, 799153L, 795232L, 809867L, 796897L, 828606L, 807116L, 848864L, 842824L, 859860L, 823586L, 898408L, 882410L, 860557L, 917587L, 802902L, 819188L, 821803L, 865168L, 877561L, 874523L, 914930L, 918135L, 922081L, 803373L, 857603L, 772681L, 844496L, 868367L, 830665L, 842774L, 909492L, 865310L, 846725L, 906674L, 821872L, 805448L, 826771L, 794728L, 836133L, 823823L, 788783L, 803635L, 788384L, 773190L, 830239L, 795936L, 808336L, 815260L, 816620L, 877807L, 807538L, 860462L, 932358L, 825122L, 731388L, 775836L, 811989L, 894457L, 843877L, 834572L, 844008L, 798540L, 757044L, 806334L, 768661L, 790512L, 806921L, 782754L, 889853L, 828350L, 918976L, 848855L, 841600L, 845575L, 881528L, 864764L, 837689L, 792031L, 843310L, 807574L, 776600L, 873572L, 761086L, 789535L, 782844L, 782342L, 798275L, 777848L, 806813L, 817457L, 782033L, 823816L, 923780L, 860756L, 905064L, 779117L, 924736L, 889547L, 871591L, 861482L, 801903L, 856956L, 838532L, 861165L, 815639L, 804207L, 781092L, 774602L, 767810L, 843278L, 865446L, 844828L, 797926L, 788804L, 865618L, 820706L, 803197L, 845594L, 773224L, 833183L, 790253L, 751143L, 805550L, 836928L, 872035L, 825456L, 821281L, 819724L, 795112L, 852341L, 855183L, 797370L, 778203L, 772410L, 791401L, 856292L, 833153L, 799171L, 822784L, 821541L, 759163L, 752725L, 823058L, 868463L, 822451L, 899865L, 844216L, 948970L, 815748L, 915963L, 805232L, 850041L, 833344L, 762889L, 772303L, 801559L, 875531L, 890538L, 863649L, 848305L, 787027L, 792015L, 872777L, 831774L, 843727L, 777726L, 841850L, 855042L, 826507L, 890151L, 862172L, 867234L, 807084L, 823491L, 879814L, 870256L, 865683L, 840722L, 883921L, 822709L, 817602L, 884516L, 882947L, 854939L, 881512L, 824609L, 798144L, 802378L, 818241L, 879895L, 842737L, 830722L, 799470L, 808440L, 850235L, 809749L, 785514L, 791097L, 776594L, 832455L, 892785L, 788375L, 788495L, 863463L, 862769L, 889916L, 811106L, 846562L, 865957L, 813880L, 782466L, 856224L, 819979L, 869952L, 847874L, 837899L, 831070L, 856048L, 785177L, 832615L, 800138L, 884286L, 795873L, 874169L, 766395L, 809265L, 808782L, 841648L, 815290L, 820532L, 862054L, 737008L, 816332L, 816139L, 827685L, 716099L, 793839L, 871866L, 790198L, 803037L, 857658L, 804356L, 829946L, 837004L, 854596L, 852902L, 830830L, 852809L, 951663L, 791412L, 726537L, 854961L, 776368L, 790938L, 866656L, 818059L, 814375L, 814944L, 863731L, 831012L, 873298L, 882825L, 858870L, 813131L, 777469L, 760245L, 846262L, 803931L, 819783L, 832909L, 798153L, 808056L, 793660L, 854528L, 787788L, 822620L, 774054L, 831390L, 783776L, 810100L, 858751L, 827689L, 846691L, 837978L, 793532L, 809838L, 869145L, 905050L, 852205L, 883292L, 842178L, 817162L, 889506L, 894851L, 870094L, 841085L, 855814L, 837060L, 807115L, 820730L, 871873L, 851383L, 798034L, 872999L, 830222L, 852534L, 938575L, 889197L, 824968L, 835481L, 839512L, 750500L, 866731L, 820721L, 778560L, 945321L, 864282L, 792698L, 827572L, 794512L, 805481L, 833082L, 965421L, 894709L, 910833L, 815178L, 876160L, 912741L, 880306L, 777420L, 793066L, 846777L, 748192L, 769122L, 757968L, 829734L, 784788L, 856758L, 810567L, 764880L, 836954L, 860819L, 796533L, 802496L, 795909L, 845091L, 826198L, 862620L, 846915L, 834737L, 940717L, 907377L, 924602L, 900260L, 925743L, 801949L, 786639L, 821518L, 781416L, 888482L, 761106L, 739423L, 790034L, 850598L, 861402L, 935786L, 829381L, 901729L, 830359L, 891445L, 887752L, 817640L, 785491L, 795245L, 810323L, 781194L), `2000` = c(623002L, 624242L, 616217L, 592639L, 583748L, 585614L, 690795L, 693421L, 602001L, 647601L, 605675L, 654182L, 592268L, 636759L, 678144L, 648945L, 603002L, 624047L, 525314L, 590073L, 629775L, 604191L, 613349L, 641110L, 713993L, 612878L, 625549L, 580745L, 673121L, 659368L, 639304L, 619525L, 609135L, 546436L, 575323L, 615426L, 632997L, 653337L, 593292L, 587688L, 586955L, 750562L, 607356L, 626066L, 672098L, 678994L, 586172L, 691128L, 652840L, 645450L, 662456L, 583551L, 624035L, 620502L, 637165L, 611527L, 588686L, 647151L, 675638L, 647716L, 671237L, 705613L, 650854L, 730317L, 682748L, 731971L, 690883L, 600261L, 644439L, 627211L, 674719L, 714834L, 683459L, 657403L, 676519L, 693983L, 642932L, 626723L, 617757L, 605236L, 611094L, 563964L, 691302L, 612467L, 726575L, 668070L, 613696L, 580994L, 630698L, 649288L, 595521L, 601646L, 659099L, 577716L, 544919L, 565508L, 619803L, 689110L, 681100L, 553541L, 621824L, 559174L, 563585L, 588928L, 715297L, 625726L, 576948L, 648725L, 711222L, 689535L, 629521L, 666957L, 675388L, 573443L, 696518L, 768811L, 782152L, 755454L, 651904L, 633796L, 597929L, 608994L, 563873L, 586791L, 654874L, 678036L, 662967L, 587534L, 639903L, 633866L, 672064L, 637044L, 662903L, 650536L, 618436L, 682133L, 671252L, 576420L, 603867L, 607666L, 625762L, 627721L, 600084L, 659013L, 619720L, 626164L, 669304L, 655971L, 627366L, 627621L, 691429L, 631387L, 682110L, 646569L, 676926L, 676009L, 669430L, 668301L, 628347L, 670451L, 589336L, 605572L, 765542L, 745622L, 729510L, 620292L, 625048L, 607340L, 674198L, 670857L, 615131L, 620510L, 575557L, 584867L, 608265L, 670113L, 589679L, 669727L, 625280L, 622701L, 621746L, 655637L, 639135L, 703318L, 650820L, 618726L, 679626L, 657204L, 589230L, 664746L, 619130L, 655486L, 623976L, 668733L, 705588L, 635774L, 699828L, 682934L, 672654L, 616230L, 645813L, 618156L, 619117L, 650202L, 590441L, 710334L, 676499L, 711776L, 656449L, 663077L, 700987L, 620943L, 646387L, 576831L, 618778L, 644937L, 638996L, 687193L, 685745L, 715900L, 597638L, 607007L, 651697L, 788743L, 708690L, 675171L, 688316L, 702854L, 665879L, 682561L, 630316L, 662773L, 619749L, 584364L, 647127L, 664971L, 617672L, 570127L, 557069L, 656042L, 593704L, 557859L, 698194L, 605274L, 660561L, 573684L, 603245L, 660703L, 598202L, 608667L, 560505L, 587840L, 620137L, 557630L, 594046L, 610577L, 641004L, 570571L, 518652L, 592932L, 603432L, 599927L, 557229L, 627641L, 714335L, 624952L, 653243L, 573531L, 613237L, 586813L, 623779L, 579472L, 625390L, 578478L, 617882L, 655284L, 620554L, 682979L, 558609L, 627021L, 589895L, 560200L, 677265L, 675118L, 648102L, 603802L, 606862L, 704429L, 669684L, 685546L, 703751L, 767665L, 611902L, 720271L, 696984L, 655172L, 724737L, 633216L, 634516L, 506751L, 597895L, 615316L, 510766L, 595097L, 618682L, 632235L, 623180L, 615080L, 622076L, 700169L, 649678L, 674569L, 596566L, 707319L, 683330L, 648893L, 662920L, 696695L, 733247L, 715806L, 649152L, 768681L, 776903L, 638533L, 744426L, 724841L, 614524L, 661551L, 659677L, 626747L, 690763L, 689462L, 601425L, 624505L, 659163L, 683751L, 728383L, 696264L, 611919L, 549857L, 572464L, 619497L, 638417L, 647293L, 598752L, 660805L, 687100L, 698289L, 606843L, 672413L, 669806L, 626389L, 651317L, 582023L, 672769L, 668300L, 653518L, 619495L, 647648L, 695623L, 698253L, 657349L, 622955L, 624036L, 601798L, 549663L, 556915L, 529487L, 576553L, 578616L, 639288L, 634470L, 643375L, 567874L, 566161L, 563035L, 566854L, 565903L, 594655L, 556623L, 574285L, 636131L, 599200L, 711574L, 680240L, 606933L, 587780L, 728468L, 686876L, 646734L, 643480L, 558807L, 598833L, 625161L, 631555L, 594777L, 609629L, 613431L, 570959L, 614972L, 621929L, 649650L, 559549L, 706570L, 609715L, 625587L, 638028L, 671152L, 688906L, 606644L, 620128L, 658882L, 651664L, 653550L, 666621L, 675314L, 645882L, 625371L, 650218L, 619381L, 601373L, 694513L, 671587L, 650513L, 614589L, 657862L, 682245L, 726499L, 683298L, 599280L, 606566L, 640972L, 652162L, 720008L, 686517L, 756594L, 617894L, 648540L, 623840L, 586779L, 686296L, 678395L, 669404L, 676493L, 688199L, 629111L, 636157L, 629856L, 709465L, 652870L, 579012L, 584750L, 605680L, 662265L, 706378L, 631039L, 590978L, 720507L, 622117L, 666082L, 590011L, 628475L, 595047L, 661832L, 598987L, 606862L, 666275L, 713765L, 720260L, 666069L, 652049L, 604502L, 607300L, 639237L, 634408L, 568941L, 584624L, 547850L, 611716L, 691272L, 638074L, 687101L, 727584L, 696396L, 701340L, 649192L, 722127L, 661150L, 634921L, 608972L, 627256L, 640055L, 629207L, 615865L, 635510L, 599103L, 631478L, 684937L, 626936L, 667640L, 603611L, 563081L, 683885L, 624754L, 538543L, 587008L, 581659L, 611670L, 600964L, 548795L, 600316L, 655053L, 667232L, 612043L, 652456L, 658832L, 672531L, 703673L, 670356L, 674242L, 667213L, 623011L, 631612L, 582706L, 597581L, 608612L, 613163L, 681282L, 607388L, 507649L, 581747L, 616773L, 557033L, 567795L, 672383L, 753554L, 699348L, 694623L, 573507L, 700029L, 672472L, 686284L, 672436L, 664973L, 638665L, 643147L, 613154L, 579958L, 668791L, 624544L, 617609L, 631336L, 636004L, 652971L, 619125L, 670600L, 615466L, 649599L, 695952L, 724306L, 668917L, 648574L, 587543L, 637967L, 553624L, 564339L, 588394L, 599189L, 658994L, 605283L, 593067L, 586117L, 595615L, 611801L, 623150L, 593079L, 571037L, 708957L, 709465L, 611110L, 732643L, 735794L, 647964L, 654664L, 616326L, 651572L, 633688L, 658767L, 694800L, 665826L, 719948L, 739954L, 706957L, 592316L, 618102L, 688409L, 666236L, 639251L, 659681L, 639732L, 764085L, 729979L, 646320L, 656098L, 691069L, 726386L, 620325L, 638396L, 724236L, 746802L, 728693L, 588003L, 689086L, 604956L, 649855L, 637306L, 647571L, 619006L, 626554L, 618918L, 613841L, 669139L, 566020L, 606995L, 594395L, 581553L, 585498L, 595304L, 617635L, 606174L, 657064L, 650096L, 686267L, 642255L, 709221L, 699571L, 672202L, 730718L, 612605L, 606348L, 617387L, 664726L, 670696L, 654850L, 711049L, 705348L, 728715L, 604716L, 647287L, 583303L, 645975L, 662686L, 635927L, 651017L, 715670L, 676874L, 647102L, 696864L, 608739L, 586946L, 627184L, 601523L, 643618L, 625025L, 582510L, 598201L, 580648L, 570165L, 638896L, 607926L, 620833L, 627056L, 626017L, 694757L, 618907L, 672254L, 751477L, 632787L, 539239L, 583667L, 635454L, 713193L, 664501L, 643150L, 657319L, 612709L, 548832L, 593167L, 552079L, 596895L, 617035L, 574670L, 677550L, 618702L, 724326L, 648334L, 654506L, 670542L, 698329L, 662500L, 647188L, 590518L, 631792L, 608255L, 597824L, 687752L, 570360L, 612827L, 596031L, 579910L, 597706L, 578846L, 622214L, 641505L, 593105L, 613683L, 734647L, 659511L, 718627L, 590157L, 733106L, 689023L, 669371L, 667349L, 606536L, 678654L, 658528L, 683701L, 632054L, 633352L, 613732L, 577908L, 577242L, 651102L, 665540L, 648202L, 592906L, 585378L, 660012L, 608279L, 582148L, 624795L, 553169L, 613555L, 580545L, 549475L, 586543L, 622749L, 665938L, 611280L, 610131L, 617603L, 613050L, 656894L, 651160L, 603607L, 579431L, 569048L, 598673L, 660374L, 643944L, 606210L, 621966L, 622864L, 571570L, 567863L, 631424L, 697319L, 627602L, 685110L, 629345L, 739523L, 622937L, 730171L, 617327L, 661212L, 628205L, 564240L, 587382L, 609061L, 682489L, 700425L, 664291L, 642000L, 622125L, 619419L, 707696L, 658943L, 658662L, 584836L, 642217L, 647534L, 607721L, 680083L, 667417L, 682066L, 625431L, 633420L, 696262L, 674280L, 677956L, 655443L, 694232L, 616734L, 612640L, 682260L, 696521L, 660739L, 707937L, 629257L, 602032L, 603346L, 614600L, 680633L, 644670L, 620981L, 591495L, 611247L, 659635L, 601635L, 581136L, 592210L, 589556L, 630211L, 690984L, 577686L, 591510L, 669388L, 651944L, 686794L, 590783L, 629385L, 661708L, 623862L, 583567L, 654120L, 611992L, 670244L, 643900L, 635618L, 626120L, 657727L, 575299L, 621100L, 616727L, 690004L, 599485L, 669825L, 566198L, 600966L, 610712L, 650722L, 618342L, 617321L, 655776L, 532400L, 624184L, 608167L, 625762L, 518768L, 625433L, 700878L, 609799L, 629231L, 680994L, 621678L, 667712L, 653526L, 652082L, 649682L, 610177L, 632191L, 738066L, 573849L, 507888L, 650435L, 572307L, 602389L, 695642L, 629391L, 638052L, 637557L, 714987L, 656465L, 691827L, 697510L, 652706L, 605046L, 565976L, 545703L, 650808L, 607507L, 633431L, 649227L, 595328L, 606677L, 606014L, 673634L, 590514L, 635398L, 575167L, 622560L, 573077L, 610264L, 655532L, 629885L, 648353L, 643416L, 603760L, 613130L, 671471L, 723669L, 662245L, 703037L, 669520L, 651822L, 723048L, 714691L, 681863L, 668905L, 684135L, 638574L, 640965L, 626773L, 686325L, 660619L, 606443L, 680117L, 643994L, 660502L, 749755L, 704475L, 637579L, 647356L, 665959L, 556414L, 670414L, 633217L, 582850L, 740929L, 663462L, 600837L, 642270L, 600531L, 597202L, 618249L, 757628L, 689802L, 720877L, 614814L, 676192L, 719919L, 689294L, 591911L, 599337L, 652586L, 545175L, 567351L, 557521L, 622149L, 578635L, 635437L, 592162L, 561382L, 646590L, 662059L, 593755L, 614869L, 601455L, 641799L, 629322L, 651038L, 632038L, 619011L, 716832L, 689797L, 705297L, 676350L, 706416L, 586911L, 571970L, 607387L, 583227L, 690820L, 571468L, 538311L, 582070L, 648090L, 673261L, 745684L, 623346L, 696082L, 629545L, 705075L, 690488L, 605934L, 586739L, 610313L, 631569L, 597269L), `2001` = c(700825L, 672763L, 645686L, 653189L, 645035L, 641809L, 783843L, 731028L, 633384L, 712145L, 721796L, 721147L, 652116L, 739092L, 798658L, 766674L, 760717L, 728350L, 662089L, 712906L, 693264L, 654730L, 684395L, 753852L, 827842L, 655426L, 658776L, 659865L, 757084L, 712100L, 747376L, 719447L, 640785L, 567776L, 634872L, 742860L, 773815L, 763128L, 701361L, 758061L, 715586L, 881848L, 724142L, 741450L, 755739L, 778292L, 682083L, 893683L, 785218L, 801932L, 821878L, 658954L, 691332L, 782883L, 770063L, 729011L, 730273L, 784248L, 793677L, 739939L, 791604L, 823178L, 768700L, 872044L, 831370L, 860001L, 806386L, 710327L, 785001L, 729205L, 769628L, 810604L, 782937L, 719379L, 765821L, 794954L, 824781L, 751150L, 767040L, 696012L, 681036L, 616889L, 739190L, 678386L, 829133L, 780438L, 691965L, 774144L, 766560L, 758919L, 680225L, 694994L, 751756L, 628993L, 607573L, 630882L, 696206L, 751030L, 820113L, 644909L, 671770L, 594740L, 615800L, 668843L, 809238L, 678176L, 654879L, 765170L, 782933L, 800016L, 741368L, 769728L, 739995L, 631886L, 824373L, 870836L, 914379L, 855553L, 783199L, 755589L, 724984L, 731574L, 692151L, 709865L, 767589L, 720652L, 673095L, 633222L, 695316L, 711007L, 782816L, 723752L, 799571L, 786918L, 675728L, 762154L, 727884L, 622002L, 679255L, 635299L, 649859L, 680840L, 664250L, 765016L, 730190L, 694975L, 760038L, 757502L, 735397L, 738202L, 783825L, 743164L, 761587L, 707150L, 757146L, 725640L, 718514L, 698936L, 670354L, 728707L, 641452L, 685876L, 873749L, 877957L, 848594L, 737676L, 722418L, 718561L, 809329L, 756681L, 714228L, 696194L, 636532L, 668580L, 695642L, 774394L, 667884L, 726984L, 660746L, 636507L, 646360L, 684046L, 696264L, 756655L, 667084L, 629190L, 746695L, 701333L, 611138L, 675310L, 637107L, 725033L, 729528L, 812656L, 870884L, 754005L, 876533L, 842945L, 818375L, 708421L, 708209L, 697235L, 676305L, 740292L, 622356L, 785559L, 740959L, 805188L, 715606L, 757297L, 817376L, 696949L, 700299L, 619201L, 651503L, 683268L, 678844L, 778145L, 838050L, 846032L, 699313L, 708311L, 717389L, 862935L, 780390L, 740444L, 755920L, 745812L, 707172L, 743022L, 709676L, 772235L, 711023L, 674251L, 746243L, 785387L, 701283L, 654646L, 598645L, 740444L, 635431L, 618011L, 725556L, 607197L, 686974L, 595326L, 650287L, 791992L, 721112L, 741354L, 666181L, 688514L, 674799L, 634648L, 677488L, 653438L, 694144L, 617390L, 571418L, 678800L, 678672L, 656320L, 599476L, 654237L, 791423L, 703218L, 723728L, 641279L, 677078L, 644009L, 689883L, 631184L, 638310L, 613587L, 683619L, 703585L, 673411L, 746231L, 602061L, 713137L, 617403L, 590133L, 717264L, 739300L, 700425L, 642501L, 635493L, 778500L, 734081L, 748674L, 770859L, 852640L, 713935L, 820302L, 784086L, 809547L, 884450L, 761596L, 767455L, 594016L, 694054L, 712854L, 594664L, 664193L, 735879L, 693297L, 686211L, 645292L, 654879L, 761731L, 701349L, 765641L, 683449L, 818646L, 758114L, 708114L, 731991L, 766528L, 848248L, 807591L, 745432L, 863617L, 874193L, 728549L, 882244L, 864495L, 719029L, 814526L, 786462L, 695788L, 822229L, 831480L, 708353L, 736989L, 780775L, 795717L, 876152L, 824486L, 720027L, 639701L, 632734L, 728138L, 706755L, 757040L, 645048L, 775153L, 739586L, 756857L, 634535L, 730965L, 714169L, 689325L, 727186L, 634955L, 754245L, 775272L, 778736L, 719008L, 754059L, 796361L, 766821L, 729161L, 656964L, 685878L, 719034L, 658805L, 663902L, 617376L, 685803L, 672795L, 765402L, 752009L, 794094L, 659137L, 646265L, 651219L, 645438L, 651206L, 652889L, 653262L, 713278L, 817101L, 698675L, 845148L, 802957L, 727222L, 698748L, 845584L, 774618L, 736149L, 732465L, 656302L, 675064L, 724591L, 714433L, 668172L, 699599L, 678296L, 628269L, 682917L, 674345L, 742470L, 628218L, 772809L, 685633L, 759682L, 780024L, 809302L, 786602L, 703030L, 693843L, 704095L, 750757L, 782749L, 760868L, 780835L, 731769L, 665365L, 741477L, 722537L, 693499L, 805313L, 761600L, 737947L, 761077L, 794246L, 801096L, 860905L, 821472L, 728279L, 759097L, 808084L, 808099L, 831246L, 760164L, 883342L, 799475L, 745443L, 721210L, 693500L, 779415L, 767070L, 735237L, 725808L, 725520L, 658052L, 646214L, 619477L, 702152L, 628245L, 558057L, 587214L, 613313L, 666475L, 724283L, 627916L, 619629L, 779670L, 655678L, 750847L, 666637L, 696752L, 682383L, 738014L, 659838L, 665488L, 751420L, 830384L, 873464L, 776028L, 741928L, 685063L, 704275L, 702590L, 718665L, 633279L, 622744L, 576734L, 641734L, 751557L, 702291L, 749403L, 805900L, 783727L, 804741L, 750491L, 820372L, 719245L, 737670L, 692883L, 662110L, 676788L, 692815L, 675989L, 697892L, 677874L, 693841L, 754624L, 708877L, 764828L, 676955L, 653146L, 785941L, 672156L, 575125L, 639788L, 617520L, 656370L, 635723L, 576712L, 639143L, 694280L, 702101L, 619739L, 679011L, 746554L, 763483L, 854310L, 827754L, 828512L, 803224L, 737447L, 747797L, 691281L, 697752L, 725206L, 676805L, 758324L, 685226L, 569723L, 704795L, 746659L, 640801L, 626840L, 724640L, 846869L, 821222L, 787185L, 638168L, 762879L, 754787L, 783690L, 777831L, 824618L, 724515L, 721101L, 666833L, 618756L, 747249L, 708922L, 699177L, 738328L, 734310L, 781141L, 710075L, 780631L, 736388L, 751850L, 800502L, 834315L, 744936L, 748797L, 688399L, 711709L, 609070L, 625194L, 644624L, 664387L, 735746L, 707040L, 703684L, 684408L, 731640L, 759988L, 755971L, 673992L, 706073L, 842844L, 777194L, 656781L, 788111L, 789444L, 691141L, 723788L, 657008L, 692747L, 696107L, 715565L, 760673L, 695362L, 789793L, 834462L, 832024L, 738789L, 718528L, 803397L, 764505L, 738090L, 759417L, 715970L, 899270L, 814864L, 715127L, 750326L, 763931L, 851081L, 741601L, 735491L, 885975L, 892188L, 860707L, 663567L, 764588L, 670159L, 729065L, 722059L, 731629L, 701804L, 729174L, 728632L, 732675L, 803916L, 683280L, 703069L, 673551L, 616207L, 605745L, 624401L, 654127L, 638652L, 693755L, 735947L, 775188L, 710732L, 779202L, 758006L, 800639L, 875020L, 756301L, 737102L, 755265L, 799893L, 787429L, 695885L, 807609L, 809573L, 809172L, 647772L, 711013L, 654562L, 742924L, 735741L, 757555L, 754733L, 809419L, 783894L, 699349L, 757163L, 633238L, 623406L, 663287L, 665158L, 709458L, 689251L, 645758L, 642003L, 603229L, 618322L, 699298L, 664538L, 736190L, 723236L, 704662L, 792930L, 766794L, 849502L, 939901L, 803556L, 616252L, 702859L, 754607L, 837127L, 752718L, 729412L, 724832L, 666104L, 579891L, 642578L, 583116L, 672509L, 678513L, 625653L, 733109L, 690844L, 860379L, 746747L, 737357L, 758177L, 771597L, 745890L, 727313L, 665463L, 690145L, 661928L, 678861L, 784475L, 629483L, 692431L, 727142L, 782383L, 724592L, 690939L, 757919L, 749153L, 668522L, 650110L, 831606L, 733231L, 795526L, 651657L, 815308L, 747883L, 745955L, 734724L, 643412L, 750422L, 741452L, 740121L, 702969L, 688120L, 658172L, 602671L, 611775L, 673023L, 744103L, 720496L, 617517L, 628769L, 713811L, 694740L, 624371L, 696158L, 623531L, 726945L, 700602L, 658580L, 716263L, 701633L, 834758L, 727254L, 778340L, 818927L, 820730L, 813770L, 760290L, 714012L, 643889L, 628942L, 634545L, 771419L, 748685L, 707845L, 678156L, 655063L, 602615L, 639015L, 714989L, 832139L, 746433L, 780761L, 737737L, 807449L, 720558L, 852125L, 781556L, 731978L, 690700L, 654134L, 664129L, 679429L, 805582L, 803403L, 760407L, 697174L, 729919L, 744978L, 869571L, 841558L, 816468L, 728390L, 825803L, 851622L, 734622L, 806298L, 731551L, 742474L, 661290L, 661216L, 736326L, 704030L, 708543L, 703959L, 763237L, 665984L, 694941L, 781211L, 795555L, 767050L, 820993L, 751705L, 741318L, 720708L, 731394L, 775422L, 712761L, 651749L, 608822L, 681316L, 733434L, 708270L, 687855L, 643632L, 613652L, 670589L, 721612L, 576275L, 603330L, 670392L, 658904L, 721765L, 632753L, 677461L, 752841L, 717269L, 672741L, 758779L, 705065L, 800201L, 717707L, 702191L, 737267L, 767281L, 622976L, 691233L, 691888L, 783269L, 644537L, 701422L, 562979L, 598686L, 655497L, 698536L, 678724L, 684328L, 713686L, 633907L, 748923L, 718087L, 783122L, 616214L, 785436L, 837561L, 720278L, 696332L, 757935L, 709144L, 744842L, 748027L, 699880L, 686595L, 653223L, 674709L, 801787L, 625823L, 542778L, 748294L, 656023L, 718942L, 795229L, 701049L, 736263L, 730687L, 846346L, 751488L, 824881L, 824545L, 759785L, 690064L, 631644L, 564764L, 716251L, 662277L, 697959L, 704200L, 625887L, 638620L, 658943L, 748318L, 625582L, 666317L, 610559L, 654469L, 560830L, 607489L, 684892L, 671386L, 669945L, 711021L, 672044L, 680155L, 736974L, 800884L, 729945L, 784176L, 752118L, 751832L, 814015L, 825359L, 783236L, 777007L, 782081L, 718790L, 746167L, 724211L, 739334L, 704031L, 648458L, 700427L, 726795L, 757690L, 839775L, 824669L, 749686L, 748730L, 793777L, 640246L, 820063L, 745708L, 659432L, 827321L, 763859L, 636383L, 733452L, 655635L, 653167L, 669088L, 817031L, 751498L, 837503L, 792021L, 827864L, 859633L, 816823L, 659420L, 678807L, 731756L, 639363L, 663508L, 664509L, 736549L, 664937L, 709169L, 641097L, 624913L, 734933L, 747051L, 666695L, 700072L, 655211L, 737346L, 708316L, 725398L, 741122L, 690237L, 772849L, 747997L, 807062L, 823520L, 805739L, 685879L, 659471L, 738646L, 673280L, 770148L, 612475L, 598588L, 637973L, 709016L, 750191L, 816687L, 703001L, 731106L, 659603L, 730808L, 752550L, 621802L, 603432L, 676474L, 701548L, 661811L), `2002` = c(737061, 697300, 671445, 696412, 688434, 736571, 888723, 787541, 697948, 747449, 804396, 721542, 640437, 794734, 926535, 903091, 848619, 888844, 796578, 737534, 674416, 675300, 704678, 803330, 881111, 676438, 730745, 728484, 882402, 791757, 843027, 803979, 701014, 612465, 701070, 813251, 845903, 783997, 711609, 765017, 724609, 884842, 717873, 773113, 785152, 829512, 695638, 949730, 824709, 899021, 895155, 659076, 696144, 811016, 814322, 741518, 729509, 798399, 788784, 723256, 798101, 851287, 785647, 935860, 868046, 904887, 828679, 719580, 834677, 822278, 836012, 842183, 876649, 796403, 832231, 844434, 913331, 802082, 817308, 743121, 676648, 610091, 750671, 755488, 938022, 877010, 796876, 906891, 854533, 830874, 716372, 674621, 724842, 597622, 586748, 599139, 747377, 825880, 913176, 670788, 681299, 588568, 588460, 735366, 874312, 704883, 690637, 830609, 824290, 890327, 809871, 785345, 731803, 617860, 851490, 895752, 944626, 888566, 858851, 827132, 798133, 785721, 722704, 742771, 791726, 734541, 666481, 633319, 679828, 713115, 792855, 699254, 829975, 774956, 650655, 731993, 721028, 616400, 689160, 641707, 650916, 732226, 698817, 815809, 826407, 819182, 887546, 864382, 827636, 894686, 946963, 835403, 850857, 786109, 841400, 763314, 747892, 751108, 694419, 776649, 656819, 692594, 919191, 963670, 939301, 766842, 746257, 758634, 859705, 792703, 749620, 718491, 654276, 801043, 783997, 874882, 742989, 832236, 710466, 647347, 676667, 737986, 809893, 842689, 711769, 629924, 756017, 687784, 566682, 652523, 616208, 736268, 788521, 892112, 960254, 837244, 944812, 925542, 885307, 743603, 762255, 753890, 694604, 782465, 594935, 836989, 877263, 963761, 833229, 908818, 929423, 716628, 705016, 627199, 650537, 680794, 687875, 787359, 866314, 870424, 706073, 646218, 646015, 814241, 736376, 696702, 758666, 738381, 723831, 735789, 711590, 750543, 696396, 677245, 778090, 788063, 701323, 660428, 607359, 834683, 659692, 628558, 761234, 608779, 732267, 628982, 720946, 832528, 792020, 807501, 737947, 743654, 662878, 648843, 706105, 657858, 658739, 604957, 527723, 670080, 660521, 656498, 564716, 633430, 871875, 763813, 748374, 664611, 705705, 695336, 793533, 737781, 676943, 654093, 712018, 758020, 785826, 858025, 684899, 783666, 664861, 646383, 849734, 878323, 795594, 731548, 614784, 799230, 790534, 795608, 756970, 859030, 704384, 809026, 793445, 854507, 942256, 797591, 883544, 642579, 737076, 815351, 652359, 761070, 833433, 745394, 742759, 677814, 714109, 822465, 730669, 866888, 709708, 877702, 750796, 695020, 759809, 795181, 878367, 816330, 721151, 877302, 924312, 700375, 901566, 874046, 713668, 836352, 833659, 735534, 842782, 850432, 768886, 785266, 799214, 776829, 926085, 893011, 737810, 711192, 691183, 791882, 766593, 820110, 718676, 820484, 766996, 770438, 651080, 691358, 663252, 677041, 756058, 706115, 838731, 814780, 821955, 746054, 778902, 841060, 758828, 715745, 612489, 649340, 782139, 630722, 654342, 607022, 701325, 676279, 753798, 732418, 781333, 626470, 589327, 615880, 604899, 601528, 590102, 612151, 722910, 882708, 750644, 853363, 827767, 751660, 756330, 957474, 918586, 888169, 878080, 772794, 779452, 857410, 820527, 735949, 766729, 730087, 672092, 702255, 662726, 729421, 618478, 784693, 696595, 796941, 816462, 874329, 921311, 830445, 759488, 738826, 816735, 866590, 878395, 899753, 794279, 697456, 849342, 776841, 778632, 877881, 772880, 766268, 776569, 867036, 846157, 916766, 850171, 748996, 760646, 852490, 899775, 920383, 816463, 954413, 880238, 770534, 696232, 668302, 783027, 830950, 781537, 760492, 740182, 644193, 606647, 595527, 750961, 642511, 574073, 595216, 624640, 704541, 746165, 645018, 657710, 889192, 715783, 880443, 754464, 772311, 757942, 808663, 723667, 702436, 771374, 936369, 998174, 836931, 788029, 714340, 772796, 769673, 785194, 697291, 678446, 605164, 718098, 842830, 836823, 887300, 864200, 827884, 837076, 782475, 893194, 750965, 747849, 680477, 621927, 647114, 655479, 657829, 690056, 693668, 720880, 823923, 791688, 843416, 704278, 641501, 787059, 698295, 582212, 654158, 634767, 677432, 641782, 606803, 639247, 723783, 686948, 591231, 681125, 802701, 846388, 1024040, 942300, 894078, 884865, 810333, 785425, 682296, 672214, 682728, 648370, 758963, 707963, 614203, 767905, 863336, 713782, 644889, 793996, 942656, 911605, 912779, 733958, 907690, 874195, 869671, 861255, 879298, 739933, 778266, 659482, 611590, 762217, 692926, 705090, 761544, 755409, 791637, 725418, 778390, 744743, 749046, 834555, 884980, 765560, 774000, 733223, 739546, 616466, 654382, 709514, 771105, 837099, 795889, 730344, 784082, 835664, 833445, 890311, 774773, 728340, 904040, 819786, 652319, 749783, 755063, 639495, 673183, 592783, 645968, 668459, 705154, 743614, 669163, 803658, 857846, 894681, 761922, 750496, 825647, 779903, 780759, 788360, 711994, 910708, 845915, 705427, 754110, 789684, 849248, 728984, 750076, 907602, 911084, 851310, 630725, 727027, 627032, 684523, 699601, 722462, 662871, 703863, 716049, 782704, 836426, 684039, 705706, 710389, 643123, 669271, 650223, 680857, 635327, 698942, 748810, 789045, 754264, 808144, 826522, 900929, 949816, 816916, 761452, 760017, 819639, 830822, 752562, 865251, 868222, 841988, 629488, 700261, 682758, 825852, 758492, 808918, 830263, 920086, 904542, 765525, 810932, 666772, 718637, 691646, 699090, 746976, 699210, 677165, 697467, 590433, 581184, 718997, 687121, 787712, 716539, 719632, 851052, 806875, 919501, 1013010, 890716, 654206, 788354, 844878, 960772, 850385, 810838, 781802, 669143, 606961, 682323, 646040, 806863, 758060, 667633, 762981, 728753, 897437, 778084, 796776, 835966, 830138, 794948, 775296, 743482, 718854, 687739, 661402, 756580, 586804, 666304, 775448, 839833, 766400, 731541, 798592, 788323, 670398, 671239, 899380, 762499, 825944, 678602, 883995, 806831, 817288, 746172, 636384, 747805, 777777, 798706, 762444, 712449, 703470, 643674, 646058, 726321, 781294, 775365, 675122, 656163, 757885, 693376, 614948, 705649, 595462, 724788, 759991, 762694, 798490, 700529, 909355, 798994, 840144, 882875, 875377, 867786, 765127, 730669, 616686, 584697, 603055, 758250, 776263, 759620, 751483, 699217, 600789, 638745, 725806, 872957, 773329, 776966, 750937, 870428, 717027, 909227, 846947, 761767, 677402, 618373, 670746, 676409, 807444, 825882, 786925, 695710, 704014, 749811, 899774, 895168, 881777, 798561, 915848, 925631, 795274, 825985, 742879, 765637, 663933, 644714, 729791, 692539, 652853, 703510, 744784, 660933, 708847, 825250, 864602, 841206, 859477, 778468, 791752, 807337, 750648, 830206, 736095, 669822, 630986, 786716, 759589, 717739, 729979, 678919, 619424, 671328, 734428, 559814, 606042, 684919, 693069, 786213, 736602, 734656, 771051, 727269, 700167, 812601, 787607, 886339, 818266, 805150, 781634, 818465, 691428, 737997, 730757, 837762, 678675, 704692, 549751, 594585, 669300, 683080, 696205, 692249, 727725, 648362, 762148, 765926, 842726, 668072, 871266, 961102, 802348, 805741, 869927, 759234, 766723, 784138, 682711, 694186, 699821, 731318, 871093, 714360, 606056, 778078, 659737, 744568, 836926, 665832, 729241, 761820, 921766, 827491, 909402, 904047, 818089, 757533, 683403, 604033, 762477, 738017, 810658, 827944, 719207, 677172, 711108, 838085, 669248, 698063, 628980, 651199, 550583, 627176, 761344, 764431, 794121, 793058, 698717, 697262, 787187, 872895, 803903, 849486, 836358, 828966, 916885, 891968, 867730, 882454, 873394, 753584, 835548, 805077, 797281, 766118, 721454, 771870, 804090, 884039, 923094, 925627, 809207, 853376, 888003, 690004, 938878, 836715, 716212, 897899, 794716, 661865, 799297, 729808, 714106, 695208, 849011, 773052, 879237, 862109, 902953, 925954, 924681, 755734, 767041, 825741, 697373, 744211, 702412, 782072, 673232, 734779, 671365, 648305, 723225, 710810, 641756, 712471, 700938, 824750, 805430, 782493, 806657, 782568, 851361, 843638, 894833, 952268, 927982, 811106, 717017, 847975, 787195, 807968, 594139, 594992, 634817, 733527, 814824, 829255, 698537, 699730, 631652, 696628, 771768, 618318, 601306, 664455, 654214, 620140), `2003` = c(808611, 751366, 720801, 757395, 711113, 770364, 922964, 887436, 816098, 806653, 917472, 705142, 656527, 847692, 1004400, 1006180, 1013260, 1048340, 859922, 785015, 760574, 725283, 713382, 828407, 939173, 835110, 805614, 825401, 1009320, 886837, 925059, 852220, 808036, 662122, 716364, 837320, 872173, 863619, 811671, 921842, 860246, 958306, 790492, 942714, 884393, 842629, 686468, 999191, 941006, 1058760, 1100480, 706353, 750633, 915121, 913157, 851693, 861942, 884913, 916698, 912343, 956557, 1074460, 1045040, 1178730, 1006820, 1055100, 941429, 823614, 918025, 892858, 847806, 847143, 890459, 812079, 855693, 860600, 961161, 846430, 1010580, 855132, 730853, 626188, 766189, 809658, 1026910, 911309, 851182, 971922, 929034, 861915, 802884, 751482, 803923, 747127, 768143, 740719, 883087, 919494, 1059790, 827296, 774314, 657065, 694065, 855851, 986738, 820674, 797296, 1005210, 852693, 901026, 861646, 847375, 807887, 688968, 903566, 889967, 911400, 879381, 892111, 866335, 810882, 786916, 725575, 707937, 787635, 747697, 710441, 715245, 760711, 825757, 869584, 841961, 904685, 871523, 733390, 794488, 759582, 654810, 793323, 747096, 643431, 712175, 706419, 811119, 866688, 867302, 999320, 943599, 858417, 978772, 986133, 856925, 888109, 877933, 899152, 830615, 807739, 817767, 724033, 811013, 640625, 767798, 1016880, 1096270, 1080490, 916148, 856081, 864894, 1001520, 923264, 814859, 803288, 774180, 1070490, 951248, 999108, 811343, 910919, 712530, 667199, 729640, 795642, 924043, 973661, 765640, 641657, 805853, 734633, 612925, 703233, 675453, 820852, 917023, 1060660, 1108530, 904694, 1039420, 1015750, 902038, 737261, 696187, 695420, 621580, 693449, 496453, 779952, 873690, 948588, 810803, 924059, 981975, 746789, 772041, 670037, 714892, 756598, 681343, 815167, 945333, 947156, 739391, 666941, 664369, 816945, 730055, 697901, 759275, 773297, 779438, 854414, 783588, 796679, 738591, 693590, 803269, 786223, 733093, 694765, 653446, 935922, 707633, 695913, 880400, 740325, 983930, 808616, 869977, 922064, 903421, 932843, 861352, 889440, 797490, 727041, 852365, 791789, 738356, 715565, 605697, 721262, 734720, 769732, 588055, 644419, 922017, 815358, 772301, 685415, 790849, 854602, 917725, 883677, 738032, 665047, 680734, 823780, 919155, 956414, 760483, 957330, 773513, 754165, 1065280, 1090450, 1049850, 899204, 688760, 907902, 875461, 915174, 805437, 937820, 808617, 895901, 935167, 925763, 1130800, 799092, 993405, 667198, 852391, 930448, 705523, 820316, 852919, 762800, 821906, 763905, 815816, 915358, 767665, 1008400, 839146, 1000520, 793784, 708089, 813428, 850836, 932258, 929137, 828823, 990274, 1048900, 745000, 973563, 993508, 758515, 893424, 859052, 797937, 979994, 950133, 993195, 989751, 929384, 815660, 1029950, 949754, 755935, 767776, 727444, 822388, 844261, 831388, 769851, 888948, 815785, 829326, 722632, 727026, 667962, 696320, 784518, 680330, 883680, 920707, 884809, 753712, 817348, 856640, 764055, 710780, 645582, 719808, 898668, 652254, 717937, 642559, 741469, 701004, 799407, 752248, 815052, 649864, 584440, 596745, 561329, 555748, 598817, 708261, 745977, 962069, 872997, 911692, 920034, 850645, 874439, 1140420, 1110290, 996998, 963703, 850677, 845518, 942321, 898960, 802389, 924335, 905628, 785040, 765018, 702371, 760736, 640069, 854583, 763069, 956591, 1026130, 1020050, 1083030, 940483, 914259, 877540, 974834, 1116410, 1037050, 1071870, 981984, 797648, 939871, 890180, 909953, 1028080, 871900, 848551, 917508, 1088780, 1016470, 1067160, 990942, 914604, 914989, 972630, 998602, 1132130, 1051610, 1074380, 1004550, 891391, 777405, 773065, 933376, 904096, 807447, 859673, 788463, 631906, 628549, 620467, 913794, 701712, 624145, 658700, 719979, 825063, 829978, 735172, 765434, 993718, 766017, 977187, 802376, 822523, 844726, 869089, 804763, 733494, 804730, 1078290, 1200130, 928031, 874847, 773690, 856607, 814131, 827266, 709928, 687928, 631628, 756492, 924724, 934062, 1018580, 1031180, 998969, 1025680, 884333, 1056630, 893848, 884290, 750318, 729846, 730512, 727732, 666949, 659852, 693443, 735673, 831652, 888271, 940202, 769792, 743128, 860489, 814694, 687031, 784905, 766624, 850126, 764114, 710462, 734615, 874707, 717193, 594226, 751183, 831752, 916074, 1111670, 1013310, 923176, 902826, 819352, 826292, 727003, 720742, 760812, 695677, 813150, 716904, 664977, 855697, 947133, 713489, 697211, 877251, 1098080, 1034330, 1029750, 831090, 1034560, 943397, 974902, 943012, 1006440, 814346, 914817, 726688, 746761, 877373, 874946, 877618, 869964, 879720, 912565, 824683, 873582, 817198, 807047, 938960, 972133, 804014, 840729, 913353, 839992, 680590, 769988, 847201, 883454, 950610, 971123, 881984, 926572, 1033680, 946155, 1061730, 914466, 911570, 1164950, 1004990, 718593, 793194, 842956, 726834, 712759, 624518, 703623, 761612, 770525, 824593, 690104, 845703, 936471, 1014680, 862431, 850164, 921617, 879187, 872448, 865340, 738589, 949724, 879489, 689916, 794223, 842577, 953132, 844694, 839997, 1120020, 1092560, 1015590, 733215, 857769, 704839, 707401, 713392, 725933, 727196, 829468, 811733, 923905, 938933, 730039, 792424, 792258, 758315, 749123, 717560, 766000, 711065, 787285, 820087, 936104, 879308, 872192, 868006, 936002, 957043, 794762, 717460, 737899, 830461, 887358, 787180, 996925, 928426, 926479, 712902, 781298, 790822, 899962, 811563, 917871, 901474, 1090090, 1082660, 796204, 922000, 703417, 831812, 740317, 747848, 817859, 725724, 712620, 733525, 559636, 569860, 747847, 698800, 852716, 744605, 731574, 876708, 881353, 990302, 1191850, 1007330, 721977, 910391, 977966, 1071800, 891842, 888096, 826245, 729866, 703034, 772185, 722166, 953156, 897867, 843717, 935047, 861718, 1098710, 881916, 1028340, 952309, 946274, 887214, 770968, 754632, 735493, 716608, 717313, 917941, 673220, 812603, 919228, 940217, 807406, 800622, 871441, 864291, 738275, 741816, 971485, 805274, 845483, 723604, 997817, 919849, 920972, 818822, 715085, 815164, 884211, 891091, 871686, 792614, 759380, 699921, 729376, 876731, 977085, 1030800, 815698, 770077, 897247, 763039, 659917, 746273, 600947, 715112, 791334, 831246, 944991, 784552, 1138740, 971282, 1115590, 1071680, 1097910, 974006, 813976, 761241, 618176, 608565, 622280, 845735, 815467, 817445, 791439, 687816, 575799, 641169, 744292, 882704, 801141, 841703, 870919, 977608, 772541, 998283, 1088430, 895100, 720821, 632784, 681415, 661282, 799091, 860620, 790388, 691307, 725057, 754697, 925146, 998775, 1070460, 944702, 1084900, 994284, 800318, 807517, 725555, 813793, 664586, 562646, 655022, 653722, 687243, 881851, 847911, 744526, 814625, 865130, 873665, 874329, 937756, 898620, 980249, 981073, 844202, 943631, 852720, 770604, 723956, 958209, 988953, 851518, 835229, 760897, 639822, 721595, 808630, 572038, 629505, 653686, 730647, 825464, 750768, 733389, 816941, 756667, 740326, 834148, 865615, 931374, 875944, 892271, 906864, 900351, 762924, 860058, 841157, 924014, 716006, 728218, 562215, 679860, 760713, 735440, 784499, 751324, 771314, 700993, 777426, 797636, 895070, 714920, 969683, 1099100, 987348, 1072160, 1021380, 892780, 829697, 816045, 701982, 748634, 825264, 828789, 958881, 811372, 681962, 806382, 717597, 826967, 916395, 717539, 797555, 845743, 1080840, 969518, 1051250, 1059020, 926889, 847629, 761243, 648625, 939251, 942182, 979093, 1000040, 871032, 854755, 849588, 1027300, 789214, 841076, 736291, 707398, 605431, 658497, 864601, 961224, 969436, 975266, 798048, 748129, 905071, 1106990, 947019, 976633, 1020310, 970924, 1075130, 1091480, 1053150, 1039080, 1017140, 872805, 933198, 913844, 802390, 837741, 838267, 894524, 992619, 1037510, 1040730, 1126810, 1004680, 1088710, 1062820, 698068, 1012820, 892961, 730741, 938432, 861623, 702853, 834818, 846179, 768941, 731845, 907656, 889873, 964698, 894820, 904775, 936480, 969602, 887619, 904923, 1000510, 801491, 774608, 734584, 813982, 669709, 733112, 726621, 755560, 783363, 744058, 700534, 795153, 753557, 859790, 841268, 779742, 830949, 835378, 923705, 967968, 1072970, 1129370, 1022390, 923277, 832137, 966997, 907535, 887813, 608820, 647387, 734632, 898920, 941689, 906584, 781265, 731292, 655332, 727357, 937819, 745733, 638298, 745518, 638593, 570378), `2004` = c(982954, 1030410, 945345, 883340, 815420, 950912, 1048640, 1106960, 1020430, 915167, 1185480, 776861, 686200, 900075, 1156550, 1211250, 1235270, 1308680, 1091400, 1092880, 934403, 910453, 854863, 908811, 1089350, 971157, 1015540, 995791, 1201870, 1063440, 1037230, 1036740, 874106, 789015, 847601, 962420, 988853, 1214560, 979397, 1242790, 1006750, 1068790, 1039990, 1235070, 1015640, 1002980, 827254, 1257750, 1281560, 1368030, 1305720, 841664, 892138, 1079340, 1059600, 1031950, 1122230, 1142690, 1082160, 1044950, 1114660, 1397300, 1548860, 1502610, 1374900, 1501290, 1215260, 1015410, 1122290, 1247480, 1135050, 1070200, 1187660, 1033720, 1027120, 992901, 1082910, 1069010, 1307100, 1177300, 899135, 756270, 965335, 970199, 1247470, 1055370, 1076770, 1249680, 1326880, 1249830, 1142050, 1042740, 1075770, 942411, 1052090, 1071460, 1139240, 1135550, 1293630, 967645, 918695, 683369, 859271, 1089860, 1231010, 994998, 992679, 1329500, 998197, 1016690, 1047850, 973571, 1148640, 876213, 1056550, 1070410, 1071920, 969846, 974824, 1036150, 885358, 968190, 864939, 790779, 879957, 822923, 820649, 874072, 942763, 918455, 879584, 840565, 949173, 986249, 916336, 1031540, 1018230, 843580, 998107, 964497, 772947, 917653, 896816, 1040500, 1016400, 992925, 1136050, 1063070, 1040150, 1212680, 1377830, 1193270, 1173270, 1086200, 1030150, 936954, 1114570, 1096170, 913307, 919267, 766242, 961385, 1147760, 1335980, 1260500, 1341770, 1169720, 1113130, 1347850, 1124700, 1047840, 1029490, 984930, 1442560, 1209780, 1315130, 1000890, 1068440, 921540, 917198, 883453, 957406, 1264740, 1249240, 932970, 768536, 948591, 803759, 647436, 749795, 754846, 940680, 1044840, 1242780, 1287730, 1014620, 1212890, 1175940, 1113080, 978739, 859178, 911346, 747560, 772921, 564603, 1011580, 1169170, 1137180, 945130, 1284100, 1298090, 846282, 985590, 800543, 830257, 859164, 714313, 943031, 1009460, 969128, 704117, 604057, 634500, 795118, 805268, 805274, 826143, 889371, 1018980, 1109710, 1012030, 1016360, 883797, 762940, 982854, 1042060, 997167, 847635, 813366, 1142950, 951251, 864659, 1144790, 974081, 1317610, 983971, 1052360, 1145860, 1110970, 1136540, 1028220, 1031190, 991243, 938418, 1170980, 1067840, 1015470, 959374, 873748, 977242, 981937, 1048690, 903341, 755959, 1132750, 918885, 895027, 776917, 924631, 1069610, 1164530, 1042350, 981596, 849704, 841111, 1031040, 1223530, 1146220, 890733, 1259960, 897508, 880818, 1285510, 1362340, 1270780, 1125720, 836768, 1101300, 1051770, 1152020, 960334, 1204090, 995765, 1050480, 1146090, 1125890, 1399300, 989196, 1368870, 884415, 1074930, 1165890, 992029, 1093880, 1177280, 908292, 935595, 855231, 916787, 989137, 796496, 1229480, 1004590, 1127850, 983426, 752035, 959682, 1056480, 1169430, 1127330, 1049550, 1285090, 1251000, 850488, 1236290, 1298760, 1053140, 1121220, 1025230, 922898, 1123510, 1107360, 1406390, 1409580, 1171600, 940461, 1197880, 1034040, 806606, 907931, 873778, 1008220, 1084920, 1052430, 1052810, 1193950, 1007850, 979106, 881346, 846510, 736853, 726095, 863628, 808739, 1031630, 1142840, 1091500, 920519, 1116760, 1116500, 959042, 930704, 889723, 903114, 1184750, 790785, 920439, 812455, 882778, 869695, 1035550, 994477, 971893, 822054, 749960, 863210, 823991, 816526, 808687, 882617, 920306, 1154930, 1198960, 1230720, 1277240, 950546, 1027860, 1331930, 1375370, 1141020, 1095740, 1020760, 1033670, 1135650, 1108660, 958672, 1091240, 969571, 800748, 819646, 718686, 751188, 615998, 847801, 749639, 1013240, 1127120, 1174510, 1261540, 1105740, 1138800, 1037610, 1176610, 1368960, 1193060, 1265930, 1235560, 1140360, 1311440, 1210990, 1175510, 1286300, 1120160, 1198020, 1326940, 1388490, 1255480, 1420810, 1234760, 1296560, 1352270, 1640140, 1607230, 1685430, 1605190, 1482550, 1261310, 1089990, 919707, 838840, 1035210, 1031270, 956662, 1037940, 874323, 665536, 678474, 779357, 1284160, 858469, 773831, 870274, 991527, 1146450, 992508, 994289, 958947, 1180280, 866000, 1072890, 901094, 1017620, 1011410, 1031570, 987548, 900746, 912107, 1251270, 1548610, 1073100, 978581, 920210, 1053650, 985319, 978501, 972429, 1013020, 919807, 969426, 1153860, 1270220, 1302290, 1267610, 1275150, 1334500, 1077380, 1436390, 1166930, 1164430, 921655, 896756, 847804, 855450, 692525, 684045, 830849, 822243, 953019, 1050640, 1129360, 913185, 862211, 1020700, 1032310, 813972, 1018980, 996459, 1172710, 1069040, 978167, 962806, 1040600, 837835, 814630, 929298, 1069370, 1301970, 1433410, 1321220, 1148680, 1098180, 1001270, 1109510, 949802, 870323, 952365, 915395, 1032390, 880957, 839604, 1089850, 1277990, 844490, 838846, 965203, 1320480, 1215950, 1165780, 994217, 1211210, 1121770, 1102500, 1087560, 1188810, 995785, 1169650, 912026, 987610, 1074550, 1164790, 1214740, 1069180, 1118660, 1064600, 877158, 945843, 849512, 835025, 1009920, 1095940, 891171, 947721, 1118750, 1001450, 778245, 915371, 971983, 1008930, 1071050, 1135620, 1067140, 1058500, 1256390, 1101160, 1347220, 1162040, 1164990, 1516830, 1377740, 851699, 906450, 981247, 838337, 801441, 765552, 761628, 895147, 865464, 1010270, 841125, 994697, 1108350, 1198400, 968698, 957678, 1032580, 1028580, 1032680, 965873, 816887, 1093170, 1157240, 883088, 973221, 1071910, 1124440, 1081890, 987408, 1427620, 1394510, 1151770, 827958, 961614, 748358, 741103, 733948, 751894, 736372, 841368, 881167, 1037610, 1171350, 816672, 912796, 973698, 894474, 923593, 832337, 932114, 851827, 1006550, 1072430, 1179680, 1058270, 1055390, 987877, 1109270, 1037570, 809922, 669599, 701047, 904249, 999014, 947253, 1255360, 1335930, 1285220, 941794, 932481, 1061300, 1129420, 998365, 1140920, 1113980, 1377340, 1349140, 938992, 1113610, 860037, 1152980, 842904, 940322, 1080720, 884948, 987667, 976896, 642549, 626774, 834668, 843386, 1065010, 997171, 984327, 1068970, 1127570, 1227980, 1407700, 1111030, 828908, 1046770, 1138420, 1306140, 1092890, 1054660, 914450, 798881, 788880, 916335, 896775, 1374180, 1210040, 1146360, 1185460, 1244310, 1536860, 1163160, 1472220, 1163430, 1243000, 1060290, 937230, 975129, 846677, 902430, 929218, 1133680, 801699, 928525, 1179450, 1162760, 1025010, 945353, 1029420, 988925, 823699, 827220, 1128230, 936605, 1061540, 847693, 1186480, 1117510, 1238580, 1034820, 870584, 1078190, 1187300, 1248200, 1215230, 1085610, 1092490, 965655, 1030590, 1155820, 1152440, 1227170, 1015450, 1046920, 1136490, 959604, 845834, 863775, 732245, 884576, 1030510, 1187930, 1248880, 843915, 1250810, 1035600, 1236080, 1203610, 1219740, 1081440, 823383, 749100, 593402, 588186, 725276, 979573, 861486, 853287, 802877, 659977, 583105, 675312, 786155, 874125, 791193, 877856, 996056, 1100610, 1146880, 1197540, 1409180, 970810, 778178, 755270, 829616, 778376, 955594, 987176, 882866, 865776, 942895, 981138, 1225040, 1304600, 1350010, 1272990, 1457100, 1325000, 1052730, 999523, 891657, 1023660, 825388, 633376, 777991, 778983, 789108, 1156730, 963477, 973788, 1118730, 1088820, 1076020, 1048680, 1081930, 1284870, 1217490, 1210260, 1001860, 1076930, 952727, 947384, 933441, 1216520, 1261230, 1086750, 1071490, 1011140, 765992, 857648, 1008600, 644641, 689399, 812972, 960579, 936480, 825159, 897287, 1057340, 895756, 996269, 1066320, 1006500, 1010770, 970877, 1072870, 1148210, 1061920, 959948, 1071110, 1102430, 1104000, 831942, 888267, 678462, 796131, 907386, 848117, 853005, 785479, 810807, 788394, 890768, 947021, 1137020, 920128, 1182610, 1363920, 1287350, 1402380, 1310020, 1182520, 1070240, 1028760, 834951, 918950, 1174630, 1113350, 1275670, 994954, 844526, 918331, 922936, 1124200, 1228050, 946189, 1110350, 1191090, 1487770, 1157940, 1194790, 1128510, 994774, 1003970, 893808, 735889, 1096560, 1187460, 1214370, 1313070, 1042130, 985526, 1115640, 1285390, 1013310, 1207230, 930732, 910053, 812902, 806465, 1131400, 1214210, 1127630, 1095900, 957499, 856311, 1030060, 1379280, 1163940, 1145780, 1223180, 1168260, 1293390, 1332080, 1252580, 1166750, 1150060, 1139750, 1229430, 1072550, 898387, 907333, 989568, 1007850, 1168720, 1259510, 1201220, 1308470, 1055100, 1322150, 1301580, 876344, 1235650, 987977, 754952, 1016820, 1056850, 726202, 866931, 956681, 796340, 815614, 1028440, 1081730, 1156340, 994788, 969870, 995836, 1110170, 1066620, 1311720, 1415130, 1018360, 1008920, 849404, 1057590, 753689, 786446, 800641, 901216, 948170, 946784, 877748, 919810, 851719, 945417, 902246, 795640, 914250, 953319, 1035490, 1273450, 1348110, 1502470, 1268180, 1142770, 913955, 1124930, 1058490, 1091100, 756456, 754481, 889761, 1187390, 1192880, 1034400, 864863, 774912, 740920, 907234, 1178500, 937603, 719179, 808083, 702599, 658780)), .Names = c("1971", "1972", "1973", "1974", "1975", "1976", "1977", "1978", "1979", "1980", "1981", "1982", "1983", "1984", "1985", "1986", "1987", "1988", "1989", "1990", "1991", "1992", "1993", "1994", "1995", "1996", "1997", "1998", "1999", "2000", "2001", "2002", "2003", "2004"), class = "data.frame", row.names = c(NA, -1000L))
scrape.sportaffinity.main = function(url, name="SportAffinity", basedir=".", url.date.format="%B %d, %Y", date.format="%Y-%m-%d", U12=2001, append=FALSE, add.to.base.url="tour/public/info/", ..., U.designation="Under ", name.delimiter="Under ", name.skip=3){ require(XML) require(RCurl) require(httr) if(!is.character(basedir) | length(basedir)!=1 ) stop("basedir must be a character vector.\n",call.=FALSE) if(!is.logical(append) | length(append)!=1) stop("append must be a TRUE/FALSE.\n",call.=FALSE) orig.append=append getthelink3=function(node){ hrefs=c() href="none" tmp=xmlChildren(node)$div if(!is.null(tmp)){ tmp=xmlChildren(tmp)$table if(!is.null(tmp)){ trs = which(names(xmlChildren(tmp))=="tr") tmp1=tmp for(i in trs){ tmp=xmlChildren(tmp1)[[i]] tds = which(names(xmlChildren(tmp))=="td") if(length(tds)!=0){ if(!is.null(xmlChildren(tmp[[tds[3]]])$b)){ if(!is.null(xmlChildren(xmlChildren(tmp[[tds[3]]])$b)$a)){ val=xmlValue(tmp[[tds[1]]]) href=xmlAttrs(xmlChildren(xmlChildren(tmp[[tds[3]]])$b)$a) hrefs=c(hrefs,href,val) } }} } } } hrefs } tmp1=str_locate(url, "://")[2] tmp2=str_locate_all(url, "/")[[1]][,2] baseurl=str_sub(url,1,min(tmp2[tmp2>tmp1])) baseurl=paste(baseurl,add.to.base.url,sep="") used.genderages = c() cat("Scraping ages. This takes awhile....\n") tmp=readHTMLTable(url, elFun=getthelink3, which=8, as.data.frame=FALSE) for(i in 1:length(tmp)){ tmp[[i]]=tmp[[i]][!is.na(tmp[[i]]) & !(tmp[[i]]=="NULL")] } tmp=unlist(tmp) div.names=tmp[seq(2,length(tmp),2)] div.links=tmp[seq(1,length(tmp),2)] for(i in 1:length(div.names)){ div.name = div.names[i] gender=str_sub(div.name,1,1) if(str_detect(div.name, "HS") | str_detect(div.name, "High School")){ ulevel=18 }else{ ulevel=str_sub(div.name,str_locate(div.name,U.designation)[2]+1,str_locate(div.name,U.designation)[2]+2) ulevel=as.numeric(ulevel) } age= U12 - (ulevel-12) age= str_sub(as.character(age),3,4) genderage=paste(gender,age,sep="") div.name = str_remove(div.name, 1, str_locate(div.name,name.delimiter)[2]+name.skip) the.dir = paste(basedir, "/", genderage,sep="") if(!file.exists(the.dir)) dir.create(the.dir) file=paste(basedir,"/",genderage,"/",name,".csv",sep="") div.link = paste(baseurl,div.links[i],sep="") venue=str_strip.white(paste(name," ",genderage," ",div.name,sep="")) cat(paste("Scraping",venue,"\n")) if(genderage %in% used.genderages) append=TRUE else append=orig.append tmp=try(scrape.sportaffinity(div.link, file=file, url.date.format=url.date.format, date.format=date.format, append=append, venue=venue, ...)) if(class(tmp)=="try-error"){ cat("There was an error scraping ", div.link, "\n") browser() } used.genderages = c(used.genderages, genderage) } }
if ( !isGeneric("calcTOAIrradModel") ) { setGeneric("calcTOAIrradModel", function(x, ...) standardGeneric("calcTOAIrradModel")) } NULL setMethod("calcTOAIrradModel", signature(x = "Satellite"), function(x, model = "MNewKur", normalize = TRUE, esd){ if(normalize == FALSE & missing(esd)){ esd <- getSatESD(x) if(is.na(esd)){ doy <- getSatDATE(x) esd <- calcEarthSunDist(doy) } } rsr <- lutInfoRSRromSID(sid = getSatSID(x)) if(normalize == TRUE){ esun <- calcTOAIrradModel(x = rsr, model = model, normalize = normalize) } else { esun <- calcTOAIrradModel(x = rsr, model = model, normalize = normalize, esd = esd) } bcde <- names(esun) x <- addSatMetaParam(x, meta_param = data.frame( BCDE = bcde, ESUN = as.numeric(esun))) return(x) }) setMethod("calcTOAIrradModel", signature(x = "data.frame"), function(x, model = "MNewKur", normalize = TRUE, esd){ toa <- lut$SOLAR toa$WAVELENGTH <- round(toa$WAVELENGTH, 0) toa_aggregated <- aggregate(toa, by = list(toa$WAVELENGTH), FUN = "mean") rsr <- x[, c(grep("BCDE", colnames(x)), grep("WAVELENGTH", colnames(x)), grep("RSR", colnames(x)))] eSun <- lapply(unique(rsr$BCDE), function(y){ rsr_solar <- merge(rsr[rsr$BCDE == y,], toa_aggregated, by = "WAVELENGTH") if(nrow(rsr_solar) > 0){ act_eSun <- aggregate( rsr_solar$RSR * rsr_solar[,grep(model, names(rsr_solar))], by = list(rsr_solar$BCDE), FUN = "sum")[2] / aggregate(rsr_solar$RSR, by = list(rsr_solar$BCDE), FUN = "sum")[2] * 1000 act_eSun <- unlist(act_eSun) } else { act_eSun <- c(NA) } names(act_eSun) <- paste0(y) return(act_eSun) }) eSun <- unlist(eSun) if(normalize == FALSE){ if(missing(esd)){ stop("Variable esd is missing.") } eSun <- eSun / esd**2 } return(eSun) })
data(TeenDeaths) barchart(deaths ~ cause, TeenDeaths, scales=list(x=list(rot=45))) barchart(deaths ~ cause, TeenDeaths, scales=list(x=list(rot=45))) table(cut(DesertBirds$count, seq(0,650,by=50))) histogram(~count, DesertBirds,n=12) densityplot(~count, DesertBirds) histogram(~mass, SockeyeFemales, breaks=seq(1,4,by=0.1)) histogram(~mass, SockeyeFemales, breaks=seq(1,4,by=0.3)) histogram(~mass, SockeyeFemales, breaks=seq(1,4,by=0.5)) plots <- list() for (b in c(0.1, 0.3, 0.5)) { p <- histogram(~mass, data=SockeyeFemales, breaks = seq(1,4,by=b), type='count', xlab = "Body mass (kg)" ) plots <- c(plots,list(p)) } for (i in 1:3) { print(plots[[i]], split=c(i,1,3,1), more=(i<3)) }
library(testthat) library(Seurat) test_check("Seurat")
getShiftNodesFromIndex <- function(ephy, index) { if (index > length(ephy$eventData)) { cat("Error. Attempting to access non-existent element from 'bammdata' object\n"); cat("You have << ", length(ephy$eventData), " >>> samples in your 'bammdata' object\n"); cat("Value of index must be no greater than the number of samples\n\n"); stop(); } root <- length(ephy$tip.label) + 1; nodes <- ephy$eventData[[index]]$node; nodes <- nodes[nodes != root]; return(nodes); }
.dynLibs <- local({ .Dyn.libs <- structure(list(), class = "DLLInfoList") function(new) { if(!missing(new)) { class(new) <- "DLLInfoList" .Dyn.libs <<- new } else .Dyn.libs } }) .libPaths <- local({ .lib.loc <- character() function(new) { if(!missing(new)) { new <- Sys.glob(path.expand(new)) paths <- c(new, .Library.site, .Library) paths <- paths[dir.exists(paths)] .lib.loc <<- unique(normalizePath(paths, "/")) } else .lib.loc } })
refPlausible <- function(refDf=NULL, units="days", RELEVANTVN_REF) { if(!is.data.frame(refDf)) { stop("Argument 'refDf' must be of class data.frame.") } if(!is.character(units)) { stop("Argument 'units' must be of class character.") } if(!any(c("auto", "secs", "mins", "hours", "days", "weeks") %in% units)) { stop("Argument 'units' received an invalid value, please select exactly one of the following options: 'auto', 'secs', 'mins', 'hours', 'days', 'weeks'. For details enter '?difftime' in the R console.") } SETUPLISTCheck(RELEVANTINFO_ES=NULL, RELEVANTVN_ES=NULL, RELEVANTVN_REF=RELEVANTVN_REF) if(any(duplicated(refDf[,RELEVANTVN_REF[["REF_ID"]]]))) { whichDupl <- which(duplicated(refDf[,RELEVANTVN_REF[["REF_ID"]]])) duplCatch <- c() for(k in 1:length(whichDupl)) { duplCatch <- c(duplCatch, which(refDf[,RELEVANTVN_REF[["REF_ID"]]] == refDf[whichDupl[k],RELEVANTVN_REF[["REF_ID"]]])) } dupl <- rep(0, times=nrow(refDf)) dupl[duplCatch] <- 1 cat("- - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - -\n") cat("- - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - -\n") cat(paste0("Duplicates in reference dataset. See column ", RELEVANTVN_REF[["REF_ID"]], ":\n")) cat("- - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - -\n") print(refDf[duplCatch,]) cat("- - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - -\n") cat("- - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - - -\n\n") stop("There are duplicated participant IDs in the reference dataset (see printed relevant part in the R console). This must be changed before proceeding!") } timeDiffUnit <- base::difftime(refDf[,RELEVANTVN_REF[["REF_END_DATETIME"]]], refDf[,RELEVANTVN_REF[["REF_START_DATETIME"]]], units=units) refDf[,paste0("ESM_PERIOD", toupper(units))] <- as.numeric(timeDiffUnit) if(!is.null(refDf[,RELEVANTVN_REF[["REF_ST"]]]) && length(refDf[,RELEVANTVN_REF[["REF_ST"]]]) > 1) { startTimeInPromptsColNames <- c(RELEVANTVN_REF[["REF_START_TIME"]], RELEVANTVN_REF[["REF_ST"]]) startTimeInPromptsBool <- apply(refDf[,startTimeInPromptsColNames], MARGIN=1, function(x) { any(as.character(x[2:length(startTimeInPromptsColNames)]) %in% as.character(x[1])) }) endTimeInPromptsColNames <- c(RELEVANTVN_REF[["REF_END_TIME"]], RELEVANTVN_REF[["REF_ST"]]) endTimeInPromptsBool <- apply(refDf[,endTimeInPromptsColNames], MARGIN=1, function(x) { any(as.character(x[2:length(endTimeInPromptsColNames)]) %in% as.character(x[1])) }) if(any(!(startTimeInPromptsBool & endTimeInPromptsBool))) { print(refDf[!(startTimeInPromptsBool & endTimeInPromptsBool),]) stop(paste0("At least one entry in one of the two colums ", RELEVANTVN_REF[["REF_START_TIME"]], " or ", RELEVANTVN_REF[["REF_END_TIME"]], " is NOT among the respective participant's prompts, although it must be. See R console.")) } idTimeAnomaly <- promptSwitchDate <- c() refDfInternal <- refDf columnsHMS <- as.character(RELEVANTVN_REF[["REF_ST"]]) for(i in columnsHMS) { refDfInternal[,i] <- as.numeric(lubridate::hms(refDfInternal[,i])) } for(j in 1:nrow(refDf)) { jDiffTemp0 <- base::diff(as.numeric(refDfInternal[j,RELEVANTVN_REF[["REF_ST"]]])) jDiffTemp <- jDiffTemp0[c(1,1:length(jDiffTemp0))] if(any(jDiffTemp <= 0)) { idTimeAnomaly <- c(idTimeAnomaly, 1) promptSwitchDate <- c(promptSwitchDate, which((jDiffTemp <= 0) == TRUE)) message(paste0("Is there an anomaly in the prospective time sequence in row ", j, " of the reference dataset? See column ", RELEVANTVN_REF[["REF_ID"]], " participant ", refDf[j,RELEVANTVN_REF[["REF_ID"]]], ".\nMaybe this is not an anomaly but instead signaling the necessity to set the argument 'midnightPrompt' to 'TRUE' in the function 'esAssign'.\n")) } else { idTimeAnomaly <- c(idTimeAnomaly, 0) promptSwitchDate <- c(promptSwitchDate, 0) } } if(!all(idTimeAnomaly == 0)) { refDf[,"TIME_ANOMALY"] <- idTimeAnomaly refDf[,"PROMPT_NEXTDAY"] <- promptSwitchDate } } return(refDf) }
favstats(score ~ type, data = TasteTest) gf_point(score ~ type, data = TasteTest) taste.lm <- lm(score ~ type, data = TasteTest) anova(taste.lm) taste.cint <- confint(glht(taste.lm, mcp(type = "Tukey"))); taste.cint plot(taste.cint)
Soap.model1 <- lm(weight ~ day, data = Soap) msummary(Soap.model1)
test_that("empty dataset gives empty layout", { i0 = iris[c(),] expect_warning(umap(i0), "small") result = suppressWarnings(umap(i0)) expect_equal(sort(names(result)), c("config", "layout")) }) test_that("single-item dataset", { i1 = iris[1,1:3] rownames(i1) = "A" expect_warning(umap(i1), "small") result = suppressWarnings(umap(i1)) expect_equal(sort(names(result)), c("config", "layout")) expected = matrix(0, ncol=2, nrow=1) rownames(expected)="A" expect_equal(result$layout, expected) }) test_that("two-item dataset", { i2 = iris[1:2,1:3] rownames(i2) = c("A", "B") expect_warning(umap(i2), "small") result = suppressWarnings(umap(i2)) expect_equal(sort(names(result)), c("config", "layout")) expect_equal(dim(result$layout), c(2,2)) expect_gt(sum(abs(result$layout[1,]-result$layout[2,])), 0) })
path.abbrev <- function(path, dir = fs::path_wd()) { fs::as_fs_path(stringr::str_replace(path, dir, "~")) }
test_that("single numerical constants are properly identified ", { is_implicit <- lintr:::is_implicit_integer x <- c("Inf", "NaN", "TRUE", "FALSE", "NA", "NA_character") y <- c(FALSE, FALSE, FALSE, FALSE, FALSE, FALSE) expect_equal(is_implicit(x), y) x <- c("2.000", "2.", "2L", "2.0", "2.1", "2") y <- c(FALSE, FALSE, FALSE, FALSE, FALSE, TRUE) expect_equal(is_implicit(x), y) x <- c("1e3", "1e3L", "1.0e3L", "1.2e3", "1.2e-3", "1e-3", "1e-33", "1.2e0") y <- c(TRUE, FALSE, FALSE, FALSE, FALSE, FALSE, FALSE, FALSE) expect_equal(is_implicit(x), y) x <- c("0x1p+0", "0x1.ecp+6L", "0x1.ecp+6", "0x1.ec66666666666p+6") y <- c(FALSE, FALSE, FALSE, FALSE) expect_equal(is_implicit(x), y) x <- c("8i", "8.0i") y <- c(FALSE, FALSE) expect_equal(is_implicit(x), y) max <- .Machine[["integer.max"]] x <- as.character(c(-max - 1.0, -max, max, max + 1.0)) y <- c(FALSE, TRUE, TRUE, FALSE) expect_equal(is_implicit(x), y) }) test_that("linter returns the correct linting", { msg <- "Integers should not be implicit. Use the form 1L for integers or 1.0 for doubles." linter <- implicit_integer_linter() expect_is(linter, "linter") expect_lint("x <<- 1L", NULL, linter) expect_lint("1.0/-Inf -> y", NULL, linter) expect_lint("y <- 1+i", list(message = msg, line_number = 1L, column_number = 7L), linter) expect_lint("z <- 1e5", list(message = msg, line_number = 1L, column_number = 9L), linter) expect_lint("cat(1:n)", list(message = msg, line_number = 1L, column_number = 6L), linter) expect_lint("552^9", list( list(message = msg, line_number = 1L, column_number = 4L), list(message = msg, line_number = 1L, column_number = 6L) ), linter) })
condSmacof_matrix <- function (d, V, u.dim, W = NULL, it.max = 1000, gamma = 1e-03, U.start = NULL, B.start = NULL) { p <- u.dim q <- dim(V)[2] N <- nrow(as.matrix(d)) if (p > (N - 1 - q)) stop("Max u.dim is N-1-vdim!") tV <- t(V) one_n_t <- t(rep(1,N)) if (is.null(W)) { W <- matrix(1, N, N) W[is.na(as.matrix(d))] <- 0 } w <- as.dist(W) H <- diag(rowSums(W)) - W G <- tV %*% H %*% V Gp <- ginv(G) GptV <- Gp %*% tV if (is.null(U.start)) U.start <- matrix(runif(N * p, min = -1), ncol = p) U <- U.start if (is.null(B.start)) B <- diag(rep(1,q)) V.tilda <- V %*% B eta.d <- sum(w*d^2) dz <- condDist(U, V.tilda, one_n_t) sigma <- rep(0, it.max) sigma[1] <- eta.d + sum(diag(t(U)%*%H%*%U)) + sum(diag(t(V.tilda) %*% H %*% V.tilda)) - 2*sum(w*d*dz) if (is.null(W)) { for (iter in 2:it.max) { cz <- -w*d/dz cz[which(cz == Inf)] <- 0 cz <- as.matrix(cz) cz_diag <- -rowSums(cz) cz <- cz + diag(cz_diag) U <- cz %*% U / N B <- GptV %*% cz %*% V.tilda V.tilda <- V %*% B dz <- condDist(U, V.tilda, one_n_t) sigma[iter] <- eta.d + sum(diag(t(U)%*%H%*%U)) + sum(diag(t(V.tilda) %*% H %*% V.tilda)) - 2*sum(w*d*dz) if (sigma[iter - 1] - sigma[iter] < gamma) break() } } else { Hp <- solve(H + 1) - N^(-2) for (iter in 2:it.max) { cz <- -w*d/dz cz[which(cz == Inf)] <- 0 cz <- as.matrix(cz) cz_diag <- -rowSums(cz) cz <- cz + diag(cz_diag) U <- Hp %*% cz %*% U B <- GptV %*% cz %*% V.tilda V.tilda <- V %*% B dz <- condDist(U, V.tilda, one_n_t) sigma[iter] <- eta.d + sum(diag(t(U)%*%H%*%U)) + sum(diag(t(V.tilda) %*% H %*% V.tilda)) - 2*sum(w*d*dz) if (sigma[iter - 1] - sigma[iter] < gamma) break() } } if (iter == it.max) { warning("Max iteration reached!") } else { sigma <- sigma[1:iter] } list(U = U, B = B, sigma = sigma, U.start = U.start, B.start = B.start) }
GetElements <- function(data, elements){ col_num <- match(elements[1], colnames(data)) num_elem <- length(elements) elems <- as.character(elements[2:num_elem]) temp_data <- data[data[ ,col_num] %in% elems, ] return(temp_data) } QuerieElemAtt <- function(q, data, start_col, exp, names, att_x, att_y, palette){ rows <- data.frame() if(length(q) == 0){ return(NULL) } for(i in 1:length(q)){ index_q <- unlist(q[[i]]$params) elem_color <- unlist(q[[i]]$color) test <- as.character(index_q[1]) check <- match(test, names) if(length(check) != 0){ if(is.na(att_y[i]) == F){ elems <- GetElements(data, index_q) end_col <- ((start_col + as.integer(length(names))) - 1) elems <- elems[which(rowSums(elems[ ,start_col:end_col]) != 0), ] if(is.null(exp) == F){ elems <- Subset_att(elems, exp) } if(nrow(elems) != 0){ elems$color <- elem_color } else{ elems <- NULL } } else if(is.na(att_y[i]) == T){ elems <- GetElements(data, index_q) end_col <- ((start_col + as.integer(length(names))) - 1) elems <- elems[which(rowSums(elems[ ,start_col:end_col]) != 0), ] if(is.null(exp) == F){ elems <- Subset_att(elems, exp) } if(nrow(elems) != 0){ elems$color <- elem_color } else{ elems <- NULL } } } else{ elems <- NULL } elems <- elems[ ,-which(names(elems) %in% names)] rows <- rbind(rows, elems) } rows <- as.data.frame(rows) if(length(rows) == 0){ return(NULL) } else{ return(rows) } } ElemBarDat <- function(q, data1, first_col, exp, names, palette, mbdata){ data1 <- data.frame(data1, check.names = F) bar <- count(data1) bar$x <- 1:nrow(bar) rows <- data.frame() act <- c() if(length(q) == 0){ return(NULL) } for(i in 1:length(q)){ index_q <- unlist(q[[i]]$params) test <- as.character(index_q[1]) check <- match(test, names) elem_color <- q[[i]]$color if(is.na(check) != T){ elem_data <- NULL } else{ elem_data <- data1[which(as.character(data1[ ,test]) %in% c(index_q[2:length(index_q)])), ] if(!is.null(exp)){ elem_data <- Subset_att(elem_data, exp) } elem_data <- as.data.frame(count(elem_data[names])) names(elem_data) <- c(names, "freq") elem_data <- elem_data[which(rowSums(elem_data[names]) != 0), ] x <- merge(mbdata, elem_data[names], by = names) elem_data <- merge(x[names], elem_data, by = names) x <- x$x elem_data$x <- x if((isTRUE(q[[i]]$active) == T) && (is.null(elem_data) == F)){ act <- T } else if((isTRUE(q[[i]]$active) == F || is.null(q[[i]]$active) == T) && (is.null(elem_data) == F)){ act <- F } elem_data$color <- elem_color elem_data$act <- act } rows <- rbind(rows, elem_data) } return(rows) }
cat("\014") rm(list = ls()) setwd("~/git/of_dollars_and_data") source(file.path(paste0(getwd(),"/header.R"))) library(ggplot2) library(reshape2) library(scales) library(grid) library(gridExtra) library(gtable) library(RColorBrewer) library(stringr) library(ggrepel) library(lubridate) library(tidyr) library(dplyr) folder_name <- "0037_bond_returns" out_path <- paste0(exportdir, folder_name) dir.create(file.path(paste0(out_path)), showWarnings = FALSE) hist_bond_stock <- readRDS(paste0(localdir, "0021_historical_returns_sp500_bond_damodaran.Rds")) cpi <- readRDS(paste0(localdir, "0021_FRED_cpi.Rds")) hist_bond_stock <-hist_bond_stock %>% left_join(cpi, by = c("Date" = "year")) %>% mutate(ret_sp500 = ret_sp500 - rate_cpi, ret_10yr_bond = ret_10yr_bond - rate_cpi, decade = Date %/% 10 * 10) %>% select(Date, decade, ret_10yr_bond, ret_sp500) min_year <- min(hist_bond_stock$Date) max_year <- max(hist_bond_stock$Date) avg_ret <- mean(hist_bond_stock$ret_10yr_bond) file_path = paste0(exportdir, "0037_bond_returns/bond-returns.jpeg") to_plot <- hist_bond_stock plot <- ggplot(data = to_plot, aes(x = Date, y = ret_10yr_bond)) + geom_bar(stat = "identity", fill = "blue") + ggtitle(paste0("U.S. 10 Year Bonds Averaged ", round(avg_ret,2)*100, "% Real Returns\n", min_year, " - ", max_year)) + scale_y_continuous(labels = percent) + of_dollars_and_data_theme + labs(x = "Year" , y = "Annual Real Return (%)") source_string <- paste0("Source: http://www.stern.nyu.edu/~adamodar/pc/datasets/histretSP.xls (OfDollarsAndData.com)") note_string <- paste0("Note: Adjusts for inflation using FRED CPI data.") my_gtable <- ggplot_gtable(ggplot_build(plot)) source_grob <- textGrob(source_string, x = (unit(0.5, "strwidth", source_string) + unit(0.2, "inches")), y = unit(0.1, "inches"), gp =gpar(fontfamily = "my_font", fontsize = 8)) note_grob <- textGrob(note_string, x = (unit(0.5, "strwidth", note_string) + unit(0.2, "inches")), y = unit(0.15, "inches"), gp =gpar(fontfamily = "my_font", fontsize = 8)) my_gtable <- arrangeGrob(my_gtable, bottom = source_grob) my_gtable <- arrangeGrob(my_gtable, bottom = note_grob) ggsave(file_path, my_gtable, width = 15, height = 12, units = "cm") file_path = paste0(exportdir, "0037_bond_returns/bond-stock-by-decade.jpeg") to_plot <- hist_bond_stock %>% select(decade, ret_10yr_bond) %>% group_by(decade) %>% summarise(count = n(), `U.S. 10-Year Bond` = prod(1 + ret_10yr_bond)^(1/count) - 1) %>% select(-count) %>% gather(key=key, value=value, -decade) plot <- ggplot(data = to_plot, aes(x = decade, y = value)) + geom_bar(stat = "identity", position = "dodge", fill = "blue") + ggtitle(paste0("Bonds Have Had Multiple Decades\nwith Negative Annualized Real Returns")) + scale_fill_discrete(guide = FALSE) + scale_color_discrete(guide = FALSE) + scale_y_continuous(labels = percent) + scale_x_continuous(breaks = seq(min(to_plot$decade), max(to_plot$decade), 10)) + of_dollars_and_data_theme + labs(x = "Decade" , y = "Annualized Real Return (%)") source_string <- paste0("Source: http://www.stern.nyu.edu/~adamodar/pc/datasets/histretSP.xls (OfDollarsAndData.com)") note_string <- paste0("Note: Adjusts for inflation using FRED CPI data.") my_gtable <- ggplot_gtable(ggplot_build(plot)) source_grob <- textGrob(source_string, x = (unit(0.5, "strwidth", source_string) + unit(0.2, "inches")), y = unit(0.1, "inches"), gp =gpar(fontfamily = "my_font", fontsize = 8)) note_grob <- textGrob(note_string, x = (unit(0.5, "strwidth", note_string) + unit(0.2, "inches")), y = unit(0.15, "inches"), gp =gpar(fontfamily = "my_font", fontsize = 8)) my_gtable <- arrangeGrob(my_gtable, bottom = source_grob) my_gtable <- arrangeGrob(my_gtable, bottom = note_grob) ggsave(file_path, my_gtable, width = 15, height = 12, units = "cm")
context("traveltimes") test_all <- (identical (Sys.getenv ("MPADGE_LOCAL"), "true") | identical (Sys.getenv ("GITHUB_WORKFLOW"), "test-coverage")) berlin_gtfs_to_zip () f <- file.path (tempdir (), "vbb.zip") g <- extract_gtfs (f, quiet = TRUE) g2 <- gtfs_timetable (g, day = 3, quiet = TRUE) test_that("gtfs_traveltimes", { from <- "Alexanderplatz" start_times <- c (12, 13) * 3600 res <- gtfs_traveltimes (g2, from, start_times) expect_is (res, "data.frame") expect_equal (ncol (res), 7) expect_true (nrow (res) > 100) expect_true (nrow (res) < nrow (g2$stops)) expect_identical (names (res), c ("start_time", "duration", "ntransfers", "stop_id", "stop_name", "stop_lon", "stop_lat")) }) test_that ("traveltime errors", { from <- "Alexanderplatz" start_times <- NULL expect_error (gtfs_traveltimes (g2, from, start_times), "start_time_limits must have exactly two entries") start_times <- 1:3 expect_error (gtfs_traveltimes (g2, from, start_times), "start_time_limits must have exactly two entries") start_times <- c ("a", "b") expect_error (gtfs_traveltimes (g2, from, start_times), "start_time_limits must be a vector of 2 integer") start_times <- 2:1 expect_error (gtfs_traveltimes (g2, from, start_times), "start_time_limits must be \\(min, max\\) values") start_time_limits <- c (43212, 49212) expect_error (gtfs_traveltimes (g2, from, start_times, max_traveltime = -1), "max_traveltime must be a single number greater than 0") g2$transfers <- NULL expect_error (gtfs_traveltimes (g2, from, start_times), "gtfs must have a transfers table") })
context("glmnet") skip_if_not_installed("modeltests") library(modeltests) skip_if_not_installed("glmnet") library(glmnet) set.seed(27) x <- matrix(rnorm(100 * 20), 100, 20) y <- rnorm(100) g <- sample(1:4, 100, replace = TRUE) fit <- glmnet(x, y) fit2 <- glmnet(x, g, family = "multinomial") cv_fit <- cv.glmnet(x, y) cv_fit2 <- cv.glmnet(x, g, family = "multinomial") test_that("glmnet tidier arguments", { check_arguments(tidy.glmnet) check_arguments(glance.glmnet) check_arguments(tidy.cv.glmnet) check_arguments(glance.cv.glmnet) }) test_that("tidy.glmnet", { td <- tidy(fit) tdz <- tidy(fit, return_zeros = TRUE) check_tidy_output(td) check_tidy_output(tdz) check_dims(td, expected_cols = 5) check_dims(tdz, expected_cols = 5) expect_true(all(td$estimate != 0)) expect_true(any(tdz$estimate == 0)) td2 <- tidy(fit2) td2z <- tidy(fit2, return_zeros = TRUE) check_tidy_output(td2) check_tidy_output(td2z) expect_true(all(td2$estimate != 0)) expect_true(any(td2z$estimate == 0)) expect_true(is.numeric(td$step) && !any(is.na(td$step))) expect_true(is.numeric(td2$step) && !any(is.na(td2$step))) }) test_that("glance.glmnet", { gl <- glance(fit) gl2 <- glance(fit2) check_glance_outputs(gl, gl2) }) test_that("tidy.cv.glmnet", { td <- tidy(cv_fit) check_tidy_output(td) check_dims(td, expected_cols = 6) td2 <- tidy(cv_fit2) check_tidy_output(td2) check_dims(td2, expected_cols = 6) }) test_that("glance.cv.glmnet", { gl <- glance(cv_fit) gl2 <- glance(cv_fit2) check_glance_outputs(gl, gl2) })
testthat::test_that("inappropriate input not flagged with error",{ x <- gsDesign() expect_error(sequentialPValue(gsD=5)) expect_error(sequentialPValue(gsD=x,n.I=1:5,Z=1:5)) expect_error(sequentialPValue(gsD=x,n.I=3:1,Z=3:1)) expect_error(sequentialPValue(gsD=gsDesign(test.type=2))) expect_error(sequentialPValue(gsD=gsDesign(test.type=3))) expect_error(sequentialPValue(gsD=gsDesign(test.type=5))) expect_error(sequentialPValue(gsD=x,n.I="bad")) expect_error(sequentialPValue(gsD=x,n.I=c(.1,.1),Z=c(.4,1.5))) expect_error(sequentialPValue(gsD=x,n.I=1,Z="bad")) expect_error(sequentialPValue(gsD=x,n.I=1,Z=2,usTime="bad")) expect_error(sequentialPValue(gsD=x,n.I=1,Z=2,interval=c(0,.999))) expect_error(sequentialPValue(gsD=x,n.I=1,Z=2,interval=c(0.01,1))) expect_error(sequentialPValue(gsD=x,n.I=1,Z=2,interval=c(0,.5,.999))) expect_error(sequentialPValue(gsD=x,n.I=(1:3)/3,Z=3:1,usTime=1:3)) })
model_parameters.t1way <- function(model, keep = NULL, verbose = TRUE, ...) { parameters <- .extract_wrs2_t1way(model) parameters <- .add_htest_parameters_attributes(parameters, model, ...) class(parameters) <- c("parameters_model", "see_parameters_model", class(parameters)) parameters } .extract_wrs2_t1way <- function(model) { fcall <- .safe_deparse(model$call) if (grepl("^(t1way|WRS2::t1way)", fcall)) { data.frame( "F" = model$test, "df" = model$df1, "df_error" = model$df2, "p" = model$p.value, "Method" = "A heteroscedastic one-way ANOVA for trimmed means", "Estimate" = model$effsize, "CI" = 1 - model$alpha, "CI_low" = model$effsize_ci[1], "CI_high" = model$effsize_ci[2], "Effectsize" = "Explanatory measure of effect size", stringsAsFactors = FALSE ) } else if (grepl("^(rmanova|WRS2::rmanova)", fcall)) { data.frame( "F" = model$test, "df" = model$df1, "df_error" = model$df2, "p" = model$p.value, "Method" = "A heteroscedastic one-way repeated measures ANOVA for trimmed means", stringsAsFactors = FALSE ) } } model_parameters.med1way <- function(model, verbose = TRUE, ...) { parameters <- .extract_wrs2_med1way(model) parameters <- .add_htest_parameters_attributes(parameters, model, ...) class(parameters) <- c("parameters_model", "see_parameters_model", class(parameters)) parameters } .extract_wrs2_med1way <- function(model) { data.frame( "F" = model$test, "Critical value" = model$crit.val, "p" = model$p.value, "Method" = "Heteroscedastic one-way ANOVA for medians", stringsAsFactors = FALSE ) } model_parameters.dep.effect <- function(model, keep = NULL, verbose = TRUE, ...) { parameters <- .extract_wrs2_dep.effect(model, keep = keep) class(parameters) <- c("parameters_model", "see_parameters_model", class(parameters)) parameters } .extract_wrs2_dep.effect <- function(model, keep = NULL, ...) { out <- as.data.frame(model) out$Parameter <- c(attributes(out)$row.names) out$Effectsize <- c( "Algina-Keselman-Penfield robust standardized difference", "Quantile shift based on the median of the distribution of difference scores", "Quantile shift based on the trimmed mean of the distribution of X-Y", "P(X<Y), Probability of first being less than second for a random pair" ) names(out) <- c( "Mu", "Estimate", "Small", "Medium", "Large", "CI_low", "CI_high", "Parameter", "Effectsize" ) out$CI <- 0.95 col_order <- c( "Parameter", "Estimate", "CI", "CI_low", "CI_high", "Effectsize", "Mu", "Small", "Medium", "Large" ) out <- out[col_order[col_order %in% names(out)]] rownames(out) <- NULL if (!is.null(keep)) { out <- out[out$Parameter == keep, ] } out } model_parameters.yuen <- function(model, verbose = TRUE, ...) { parameters <- .extract_wrs2_yuen(model) parameters <- .add_htest_parameters_attributes(parameters, model, ...) class(parameters) <- c("parameters_model", "see_parameters_model", class(parameters)) parameters } .extract_wrs2_yuen <- function(model) { fcall <- .safe_deparse(model$call) if (grepl("^(yuen\\(|WRS2::yuen\\()", fcall) || grepl("function (formula, data, tr = 0.2, ...)", fcall, fixed = TRUE)) { out <- data.frame( "t" = model$test, "df_error" = model$df, "p" = model$p.value, "Method" = "Yuen's test on trimmed means for independent samples", "Difference" = model$diff, "CI" = 0.95, "Difference_CI_low" = model$conf.int[1], "Difference_CI_high" = model$conf.int[2], "Estimate" = model$effsize, "Effectsize" = "Explanatory measure of effect size", stringsAsFactors = FALSE ) } else { out <- data.frame( "t" = model$test, "df_error" = model$df, "p" = model$p.value, "Method" = "Yuen's test on trimmed means for dependent samples", "Difference" = model$diff, "CI" = 0.95, "Difference_CI_low" = model$conf.int[1], "Difference_CI_high" = model$conf.int[2], "Estimate" = model$effsize, "Effectsize" = "Explanatory measure of effect size", stringsAsFactors = FALSE ) } out } model_parameters.mcp1 <- function(model, verbose = TRUE, ...) { parameters <- .extract_wrs2_mcp12(model) parameters <- .add_htest_parameters_attributes(parameters, model, ...) class(parameters) <- c("parameters_model", "see_parameters_model", class(parameters)) parameters } model_parameters.mcp2 <- model_parameters.mcp1 .extract_wrs2_mcp12 <- function(model) { out <- as.data.frame(model$comp) names(out)[1:6] <- c("Group1", "Group2", "Psihat", "CI_low", "CI_high", "p") out$Group1 <- model$fnames[model$comp[, 1]] out$Group2 <- model$fnames[model$comp[, 2]] out$CI <- 1 - model$alpha col_order <- c("Group1", "Group2", "Psihat", "CI", "CI_low", "CI_high", "p", "p.crit") out <- out[col_order[col_order %in% names(out)]] out } model_parameters.robtab <- function(model, verbose = TRUE, ...) { parameters <- .extract_wrs2_robtab(model) parameters <- .add_htest_parameters_attributes(parameters, model, ...) class(parameters) <- c("parameters_model", "see_parameters_model", class(parameters)) parameters } .extract_wrs2_robtab <- function(model) { fcall <- .safe_deparse(model$call) out <- as.data.frame(model$partable) if (grepl("^(discmcp\\(|WRS2::discmcp\\()", fcall)) { names(out)[1:3] <- c("Group1", "Group2", "p") } if (grepl("^(discstep\\(|WRS2::discstep\\()", fcall)) { names(out)[1:2] <- c("Groups", "p") } if (grepl("^(binband\\(|WRS2::binband\\()", fcall)) { names(out)[1:4] <- c("Value", "Probability1", "Probability2", "Difference") if ("p.value" %in% names(out)) { out$p <- out$p.value out$p.value <- NULL } } out } model_parameters.onesampb <- function(model, verbose = TRUE, ...) { parameters <- .extract_wrs2_onesampb(model) parameters <- .add_htest_parameters_attributes(parameters, model, ...) class(parameters) <- c("parameters_model", "see_parameters_model", class(parameters)) parameters } .extract_wrs2_onesampb <- function(model) { data.frame( "Estimate" = model$estimate, "CI" = 1 - model$alpha, "CI_low" = model$ci[1], "CI_high" = model$ci[2], "p" = model$p.value, "n_Obs" = model$n, "Effectsize" = "Robust location measure", "Method" = "One-sample percentile bootstrap", stringsAsFactors = FALSE ) } model_parameters.trimcibt <- function(model, verbose = TRUE, ...) { parameters <- .extract_wrs2_trimcibt(model) parameters <- .add_htest_parameters_attributes(parameters, model, ...) class(parameters) <- c("parameters_model", "see_parameters_model", class(parameters)) parameters } .extract_wrs2_trimcibt <- function(model) { data.frame( "t" = model$test.stat, "p" = model$p.value, "n_Obs" = model$n, "Method" = "Bootstrap-t method for one-sample test", "Estimate" = model$estimate[[1]], "CI" = 1 - model$alpha, "CI_low" = model$ci[1], "CI_high" = model$ci[2], "Effectsize" = "Trimmed mean", stringsAsFactors = FALSE ) } model_parameters.AKP <- function(model, verbose = TRUE, ...) { parameters <- .extract_wrs2_AKP(model) parameters <- .add_htest_parameters_attributes(parameters, model, ...) class(parameters) <- c("parameters_model", "see_parameters_model", class(parameters)) parameters } .extract_wrs2_AKP <- function(model) { data.frame( "Estimate" = model$AKPeffect, "CI" = 1 - model$alpha, "CI_low" = model$AKPci[1], "CI_high" = model$AKPci[2], "Effectsize" = "Algina-Keselman-Penfield robust standardized difference", stringsAsFactors = FALSE ) } model_parameters.wmcpAKP <- function(model, verbose = TRUE, ...) { parameters <- .extract_wrs2_wmcpAKP(model) class(parameters) <- c("parameters_model", "see_parameters_model", class(parameters)) parameters } .extract_wrs2_wmcpAKP <- function(model) { data.frame( "Estimate" = model[[1]], "CI" = 0.95, "CI_low" = model[[2]], "CI_high" = model[[3]], "Effectsize" = "Algina-Keselman-Penfield robust standardized difference average", stringsAsFactors = FALSE ) }
bayessurvreg2.priorBeta <- function(prior.beta, init, design) { if (design$nX){ if(length(init) == 0) ininit <- "arnost" else ininit <- names(init) tmp <- match("beta", ininit, nomatch=NA) if(is.na(tmp)){ init.beta <- rep(0, design$nX) } else{ if (length(init$beta) < design$nX) stop("Incorrect init$beta parameter supplied.") init.beta <- init$beta[1:design$nX] } if (sum(is.na(init.beta))) stop("Incorrect init$beta parameter supplied.") if(length(prior.beta) == 0) inprior <- "arnost" else inprior <- names(prior.beta) tmp <- match("mean.prior", inprior, nomatch=NA) if(is.na(tmp)) stop("Prior means for betas must be specified.") tmp <- match("var.prior", inprior, nomatch=NA) if(is.na(tmp)) stop("Prior vars for betas must be specified.") if (length(prior.beta$mean.prior) != design$nX) stop("Incorrect length of a vector of prior means for betas.") if (length(prior.beta$var.prior) != design$nX) stop("Incorrect length of a vector of prior vars for betas.") if (sum(is.na(prior.beta$mean.prior))) stop("Prior means for betas must not be missing.") if (sum(is.na(prior.beta$var.prior))) stop("Prior vars for betas must not be missing.") if (sum(prior.beta$var.prior <= 0)) stop("Prior vars for betas must be all positive.") mean.prior <- prior.beta$mean.prior var.prior <- prior.beta$var.prior ngamma <- design$nrandom - 1*(design$randomInt) nFixed <- design$nX - ngamma parmI <- c(design$nX, nFixed, ngamma, 1*design$randomInt, design$indb) parmD <- c(init.beta, mean.prior, var.prior) names(parmI) <- c("nbeta", "nFixed", "ngamma", "randomIntcpt", paste("indbA", 1:design$nX, sep="")) names(parmD) <- c(paste("beta", 1:design$nX, sep=""), paste("mean.beta", 1:design$nX, sep=""), paste("var.beta", 1:design$nX, sep="")) } else{ if (!is.null(design$randomInt)){ init.beta <- numeric(0) mean.prior <- numeric(0) var.prior <- numeric(0) if (is.null(design$indb)) parmI <- c(0, 0, 0, 1*design$randomInt, 0) else parmI <- c(0, 0, 0, 1*design$randomInt, design$indb) parmD <- c(0, 0, 0) names(parmI) <- c("nbeta", "nFixed", "ngamma", "randomIntcpt", "indbA") names(parmD) <- c("beta", "mean.beta", "var.beta") } else{ init.beta <- numeric(0) mean.prior <- numeric(0) var.prior <- numeric(0) parmI <- c(0, 0, 0, 0, 0) parmD <- c(0, 0, 0) names(parmI) <- c("nbeta", "nFixed", "ngamma", "randomIntcpt", "indbA") names(parmD) <- c("beta", "mean.beta", "var.beta") } } toreturn <- list(parmI=parmI, parmD=parmD) attr(toreturn, "init") <- init.beta attr(toreturn, "prior.beta") <- list(mean.prior=mean.prior, var.prior=var.prior) return(toreturn) }
SDMXCrossSectionalData <- function(xmlObj, namespaces){ new("SDMXCrossSectionalData", SDMXData(xmlObj, namespaces) ) } as.data.frame.SDMXCrossSectionalData <- function(x, row.names=NULL, optional=FALSE, labels = FALSE, ...){ xmlObj <- x@xmlObj; dataset <- NULL schema <- slot(x,"schema") sdmxVersion <- slot(schema,"version") hasAuthorityNS <- FALSE nsDefs.df <- getNamespaces(x) ns <- findNamespace(nsDefs.df, "crosssection") authorityNs <- nsDefs.df[ regexpr("http://www.sdmx.org", nsDefs.df$uri, "match.length", ignore.case = TRUE) == -1,] authorityNs <- as.data.frame(authorityNs, stringsAsFactors = FALSE) colnames(authorityNs) <- "uri" if(nrow(authorityNs) > 0){ hasAuthorityNS <- TRUE if(nrow(authorityNs) > 1){ warning("More than one target dataset namespace found!") authorityNs <- authorityNs[1L,] authorityNs <- as.data.frame(authorityNs, stringsAsFactors = FALSE) colnames(authorityNs) <- "uri" } } if(hasAuthorityNS){ groupsXML <- getNodeSet(xmlObj, "//ns:Group", namespaces = c(ns = authorityNs$uri)) if(length(groupsXML) == 0){ groupsXML <- getNodeSet(xmlObj, "//ns:Group", namespaces = ns) } }else{ if(length(ns) > 0){ groupsXML <- getNodeSet(xmlObj, "//ns:Group", namespaces = ns) }else{ if(nrow(nsDefs.df) > 0){ groupNs <- nsDefs.df[1,] groupsXML <- getNodeSet(xmlObj, "//nt:Group", c(nt = groupNs$uri)) }else{ stop("Unsupported CrossSectionalData parser for empty target XML namespace") } } } if(length(groupsXML) == 0){ groupsXML <- getNodeSet(xmlObj, "//Group") } groupsNb <- length(groupsXML) if(groupsNb == 0) return(NULL); parseSection <- function(x){ sectionAttrs <- xmlAttrs(x) sectionAttrs <- as.data.frame(t(sectionAttrs), stringsAsFactors = FALSE) sectionChildren <- xmlChildren(x) secObs <- names(sectionChildren) secValues <- do.call("rbind.fill", lapply(sectionChildren, function(x) { attrs <- xmlAttrs(x) return(as.data.frame(t(attrs), stringsAsFactors = FALSE)) })) secContent <- data.frame(sectionAttrs, obs = secObs, secValues, stringsAsFactors = FALSE) return(secContent) } parseGroup <- function(x){ groupAttrs <- xmlAttrs(x) groupAttrs <- as.data.frame(t(groupAttrs), stringsAsFactors = FALSE) x <- xmlDoc(x) if(hasAuthorityNS){ secXML <- getNodeSet(x, "//ns:Section", namespaces = c(ns = authorityNs$uri)) if(length(secXML) == 0){ secXML <- getNodeSet(x, "//ns:Section", namespaces = ns) } }else{ if(length(ns) > 0){ secXML <- getNodeSet(x, "//ns:Section", namespaces = ns) }else{ if(nrow(nsDefs.df) > 0){ secNs <- nsDefs.df[1,] secXML <- getNodeSet(x, "//nt:Section", c(nt = secNs$uri)) }else{ stop("Unsupported CrossSectionalData parser for empty target XML namespace") } } } if(length(secXML) == 0){ secXML <- getNodeSet(xmlObj, "//Section") } secNb <- length(secXML) if(secNb == 0) return(NULL); sections <- do.call("rbind.fill", lapply(secXML, parseSection)) group <- data.frame(groupAttrs, sections) return(group) } dataset <- do.call("rbind.fill", lapply(groupsXML, parseGroup)) if(any(as.character(dataset$obsValue) == "NaN", na.rm = TRUE)){ dataset[as.character(dataset$obsValue) == "NaN",]$obsValue <- NA } if(!is.null(dataset)) base::row.names(dataset) <- 1:nrow(dataset) if(labels){ dsd <- slot(x, "dsd") if(!is.null(dsd)) dataset <- addLabels.SDMXData(dataset, dsd) } return(encodeSDMXOutput(dataset)) }
library(SuperGauss) if(!identical(Sys.getenv("NOT_CRAN"), "true")) { set.seed(1) } test_fbm_acf <- function(alpha, dT, N) { msd <- fbm_msd(dT*(1:N), alpha/2) msd2acf(msd) } test_exp_acf <- function(lambda, order, N) { pex_acf(0:(N-1)/N, rho = order, lambda = 1/lambda^(1/order)) } test_matern_acf <- function(lambda, nu, N) { matern_acf(0:(N-1), lambda, nu) } test_acf_func <- function(N, type, first0 = FALSE) { lambda <- 1 / runif(1, 1, 3) alpha <- runif(1, .2, .9) nu <- 3 dT <- runif(1, .1, .9) type <- match.arg(type, choices = c("exp", "exp2", "fbm", "matern", "zero", "rnd")) if(type == "exp2") { acf <- test_exp_acf(lambda, 2, N) } else if(type == "exp") { acf <- test_exp_acf(lambda, 1, N) } else if(type == "fbm") { acf <- test_fbm_acf(alpha, dT, N) } else if(type == "matern") { acf <- test_matern_acf(lambda, nu, N) } else if(type == "zero") { acf <- rep(0, N) } else { acf <- rnorm(N) } if(first0) acf[1] <- 0 acf } test_fbm_acf_grad <- function(alpha, dT, N) { if(N == 1) { dacf <- dT^alpha * log(alpha) } else { dacf <- c(0, (dT*(1:N))^alpha * log(dT*(1:N))) dacf <- .5 * (dacf[1:N+1] + c(dacf[2], dacf[1:(N-1)]) - 2*dacf[1:N]) } dacf } test_fbm_acf_hess <- function(alpha, dT, N) { if(N == 1) { d2acf <- dT^alpha * log(alpha)^2 } else { d2acf <- c(0, (dT*(1:N))^alpha * log(dT*(1:N))^2) d2acf <- .5 * (d2acf[1:N+1] + c(d2acf[2], d2acf[1:(N-1)]) - 2*d2acf[1:N]) } d2acf } test_drift_func <- function(mu, N){ rep(mu^2, N) } test_drift_grad <- function(mu, N){ rep(2 * mu, N) } test_drift_hess <- function(mu, N){ rep(2, N) } toep_ldens <- function(z, gamma) { mvtnorm::dmvnorm(x = z, sigma = toeplitz(gamma), log = TRUE) } fft <- function(x) { eV <- is.vector(x) x <- as.matrix(x) if(nrow(x) == 1) { y <- x + 0i } else { y <- apply(as.matrix(x), 2, fftw::FFT) } if(eV) y <- drop(y) y } ifft <- function(x) { eV <- is.vector(x) x <- as.matrix(x) if(nrow(x) == 1) { y <- x + 0i } else { y <- apply(as.matrix(x), 2, fftw::FFT, inverse = TRUE) } y <- Re(y)/nrow(y) if(eV) y <- drop(y) y } unfold_acf <- function(N, uacf) { n <- length(uacf) if(n != floor(N/2) + 1) stop("uacf has wrong length.") acf <- rep(NA, N) acf[1:n] <- uacf if(N > 1) { eN <- (2*n) == (N+2) id <- n - eN + (2:n-1) acf[n - eN + (2:n-1)] <- uacf[n:2] } acf } circulant <- function(x) { N <- length(x) t(sapply(1:N-1, function(ii) x[(1:N-1 - ii) %% N + 1])) } circ_ldens <- function(z, nu) { N <- if(is.matrix(z)) ncol(z) else length(z) mvtnorm::dmvnorm(z, log = TRUE, sigma = toeplitz(unfold_acf(N, nu))) }
setMethod("$", "Raster", function(x, name) { x[[name]] } ) setMethod("$<-", "Raster", function(x, name, value) { i <- which(name == names(x))[1] if (is.na(i)) { if (inherits(value, 'Raster')) { names(value) <- name x <- addLayer(x, value) return(x) } else { r <- raster(x) names(r) <- name r[] <- value x <- addLayer(x, r) return(x) } } else { if (inherits(value, 'Raster')) { if (inherits(x, 'RasterLayer')) { if (name == names(x)) { x <- value } else { x <- stack(x) x[[name]] <- value } } else { x[[name]] <- value } } else { r <- x[[name]] r[] <- value x[[name]] <- value } return(x) } } ) setMethod("[[", "Raster", function(x,i,j,...,drop=TRUE) { if ( missing(i)) { stop('you must provide an index') } if (! missing(j)) { warning('second index is ignored') } if (is.numeric(i)) { sgn <- sign(i) sgn[sgn==0] <- 1 if (! all(sgn == 1) ) { if (! all(sgn == -1) ) { stop("only 0's may be mixed with negative subscripts") } else { i <- (1:nlayers(x))[i] } } } subset(x, i, drop=drop) }) setReplaceMethod("[[", c("RasterStackBrick", "character", "missing"), function(x, i, j, value) { if (inherits(value, 'Raster')) { names(value) <- i } n <- which(i == names(x))[1] if (is.na(n)) { n <- nlayers(x) + 1 } x[[n]] <- value x } ) setReplaceMethod("[[", c("RasterLayer", "character", "missing"), function(x, i, j, value) { stopifnot(length(i) == 1) if (i[1] != names(x)) { x <- stack(x) x[[i]] <- value return(x) } if (inherits(value, 'RasterLayer')) { names(value) <- i return(value) } else if (inherits(value, 'Raster')) { if (nlayers(value) == 1) { value <- value[[1]] names(value) <- i return(value) } else { stop("too many layers") } } setValues(x, value) } ) setReplaceMethod("[[", c("RasterStack", "numeric", "missing"), function(x, i, j, value) { i <- round(i) if (i < 1) { stop('index should be > 0') } nl <- nlayers(x) if (i > nl + 1) { stop('index should be <= nlayers(x)+1') } if (!inherits(value, 'RasterLayer')) { val <- value if (i > nl) { value <- x[[nl]] } else { value <- x[[i]] } value[] <- val } else { compareRaster(x, value) } if (i > nl) { x <- addLayer(x, value) } else { x@layers[[i]] <- value } x } ) setReplaceMethod("[[", c("Raster", "numeric", "missing"), function(x, i, j, value) { i <- round(i) if (i < 1) { stop('index should be > 0') } nl <- nlayers(x) if (i > nl + 1) { stop('index should be <= nlayers(x)+1') } if (inherits(x, "RasterLayer")) { return(value) } if (canProcessInMemory(x)) { if (!inMemory(x)) { x <- readAll(x) } if (inherits(value, 'RasterLayer')) { compareRaster(x, value) x <- setValues(x, getValues(value), i) names(x)[i] <- names(value) } else { val <- value if (i > nl) { value <- getValues(x[[nl]]) } else { value <- getValues(x[[i]]) } value[] <- val x <- setValues(x, value, i) } } else { x <- stack(x) x[[i]] <- value } return(x) } ) setReplaceMethod("[", c("RasterStackBrick", "Raster", "missing"), function(x, i, j, value) { nl <- nlayers(i) if (! hasValues(i) ) { i <- cellsFromExtent(x, i) } else if (compareRaster(x, i, stopiffalse=FALSE, showwarning=FALSE)) { dims <- dim(i) i <- as.logical(getValues(i)) dim(i) <- c(prod(dims[1:2]), dims[3]) } else { i <- cellsFromExtent(x, i) } if (nl < nlayers(x)) { .replace(x, i, value=value, recycle=nl) } else { .replace(x, i, value=value, recycle=0) } } ) setReplaceMethod("[", c("Raster", "Extent", "missing"), function(x, i, j, value) { i <- cellsFromExtent(x, i) .replace(x, i, value=value, recycle=1) } ) setReplaceMethod("[", c("Raster", "Spatial", "missing"), function(x, i, j, value) { if (inherits(i, 'SpatialPolygons')) { v <- 1:length(i@polygons) v[] <- value return( .polygonsToRaster(i, x, field=v, fun='last', mask=FALSE, update=TRUE, updateValue="all", silent=TRUE) ) } else if (inherits(i, 'SpatialLines')) { v <- 1:length(i@lines) v[] <- value return( .linesToRaster(i, x, field=v, fun='last', mask=FALSE, update=TRUE, updateValue="all", silent=TRUE) ) } else { i <- cellFromXY(x, sp::coordinates(i)[,1:2,drop=FALSE]) return( .replace(x, i, value=value, recycle=1) ) } } ) setReplaceMethod("[", c("RasterStackBrick","missing","missing"), function(x, i, j, value) { nl <- nlayers(x) if (inherits(x, 'RasterStack')) { x <- brick(x, values=FALSE) } if (is.matrix(value)) { if (all(dim(value) == c(ncell(x), nl))) { x <- try( setValues(x, value)) } else { stop('dimensions of the matrix do not match the Raster* object') } } else { v <- try( matrix(nrow=ncell(x), ncol=nl) ) if (! inherits(x, "try-error")) { v[] <- value x <- try( setValues(x, v) ) } } if (inherits(x, "try-error")) { stop('cannot set values on this raster (it is too large)') } return(x) } ) setReplaceMethod("[", c("Raster", "numeric", "numeric"), function(x, i, j, value) { i <- cellFromRowColCombine(x, i, j) .replace(x, i, value, recycle=1) } ) setReplaceMethod("[", c("Raster","missing", "numeric"), function(x, i, j, value) { j <- cellFromCol(x, j) .replace(x, j, value=value, recycle=1) } ) setReplaceMethod("[", c("Raster","numeric", "missing"), function(x, i, j, value) { theCall <- sys.call(-1) narg <- length(theCall)-length(match.call(call=sys.call(-1))) if (narg > 0) { i <- cellFromRow(x, i) } .replace(x, i=i, value=value, recycle=1) } ) setReplaceMethod("[", c("Raster", "matrix", "missing"), function(x, i, j, value) { if (ncol(i) == 2) { i <- cellFromRowCol(x, i[,1], i[,2]) } else { i <- as.vector(i) } .replace(x, i=i, value=value, recycle=1) } ) setReplaceMethod("[", c("Raster", "logical", "missing"), function(x, i, j, value) { .replace(x, i, value, recycle=1) } )
expect_redactor <- function(expr) { expect_identical(names(formals(expr)), "response") } test_that("prepare_redactor: function", { expect_identical(prepare_redactor(redact_cookies), redact_cookies) }) multiredact <- list(redact_cookies, ~ redact_headers(., "X-Header")) test_that("prepare_redactor: list/multiple", { expect_redactor(prepare_redactor(multiredact)) expect_identical(prepare_redactor(multiredact[1]), redact_cookies) }) test_that("prepare_redactor: NULL for no redacting", { expect_identical(prepare_redactor(NULL), force) }) test_that("prepare_redactor: garbage", { expect_error( prepare_redactor("foo"), "Redactor must be a function or list of functions" ) }) test_that("get_current_redactor edge cases", { options(httptest.redactor = NULL) expect_identical(get_current_redactor(), redact_auth) options(httptest.redactor.packages = "NOTAPACKAGE") expect_identical(get_current_redactor(), redact_auth) }) with_mock_api({ test_that("Reading redactors from within a package (and install that package)", { newmocks <- tempfile() testthat_transition( expect_message( capture_while_mocking(path = newmocks, { lib <- install_testpkg("testpkg") library(testpkg, lib.loc = lib) expect_true("testpkg" %in% names(sessionInfo()$otherPkgs)) r <- GET("http://example.com/get") }), paste0("Using redact.R from ", dQuote("testpkg")) ), expect_message( expect_message( capture_while_mocking(path = newmocks, { lib <- install_testpkg("testpkg") library(testpkg, lib.loc = lib) expect_true("testpkg" %in% names(sessionInfo()$otherPkgs)) r <- GET("http://example.com/get") }), paste0("Using redact.R from ", dQuote("testpkg")) ), paste0("Using request.R from ", dQuote("testpkg")) ) ) with_mock_path(newmocks, { r2 <- GET("http://example.com/get") }) expect_identical(content(r2), list(fake = TRUE)) }) test_that("Request preprocessing via package inst/httptest/request.R", { expect_identical( content(GET("http://pythong.org/api/object1/")), content(GET("api/object1/")) ) }) test_that("set_redactor(NULL) to override default (and loaded packages)", { expect_true("testpkg" %in% names(sessionInfo()$otherPkgs)) on.exit(detach("package:testpkg", unload = TRUE)) newmocks2 <- tempfile() with_redactor( NULL, capture_while_mocking(simplify = FALSE, path = newmocks2, { a <- POST("http://example.com/login", body = list(username = "password"), encode = "json" ) }) ) expect_true(any(grepl( "token=12345", readLines(file.path(newmocks2, "example.com", "login-712027-POST.R")) ))) }) test_that("Loading a package with pkgload (devtools)", { newmocks3 <- tempfile() expect_false("testpkg" %in% names(sessionInfo()$otherPkgs)) on.exit(pkgload::unload("testpkg")) expect_message( capture_while_mocking(path = newmocks3, { pkgload::load_all("testpkg", quiet = TRUE) expect_true("testpkg" %in% names(sessionInfo()$otherPkgs)) r <- GET("http://example.com/get") }), paste0("Using redact.R from ", dQuote("testpkg")) ) with_mock_path(newmocks3, { r2 <- GET("http://example.com/get") }) expect_identical(content(r2), list(fake = TRUE)) }) }) reset_redactors()
context("data from gh release") test <- function(class = c("sf", "sp"), ...) { class <- match.arg(class) get_big_data("test", class, ...) } test_that("get_big_data works with specific release", { skip_on_cran() skip_on_actions() expect_equal(get_big_data("test", "sf", "0.1.1", force = TRUE, ask = FALSE), "test") expect_equal(test(release = "0.1.1", force = TRUE, ask = FALSE), "test") test_gh_assid_file <- file.path(data_dir(), "test.gh_asset_id") expect_true(file.exists(test_gh_assid_file)) expect_equal(readChar(test_gh_assid_file, nchars = 10), "5416227") }) test_that("get_big_data works with latest release", { skip_on_cran() skip_on_actions() expect_equal(get_big_data("test", "sf", "latest", force = TRUE, ask = FALSE), "test") expect_equal(test(force = TRUE, ask = FALSE), "test") }) test_that("get_big_data fails when file doesn't exist", { skip_on_cran() skip_on_actions() expect_error(get_big_data("test", "sf", "0.1.0", force = TRUE, ask = FALSE), "No assets matching filename test.rds in 0.1.0 release") }) test_that("gh functions work with and without authentication", { skip_on_travis() skip_on_cran() skip_on_actions() gh_pat <- "" if (nzchar(Sys.getenv("GITHUB_PAT"))) { expect_is(get_gh_release("latest"), "list") temp <- tempfile(fileext = ".rds") download_release_asset("https://api.github.com/repos/bcgov/bcmapsdata/releases/assets/5432872", temp) expect_equal(readRDS(temp), "test") gh_pat <- Sys.getenv("GITHUB_PAT") Sys.unsetenv("GITHUB_PAT") } expect_is(get_gh_release("latest"), "list") temp <- tempfile(fileext = ".rds") download_release_asset("https://api.github.com/repos/bcgov/bcmapsdata/releases/assets/5432872", temp) expect_equal(readRDS(temp), "test") Sys.setenv("GITHUB_PAT" = gh_pat) })
calc_E = function(x, temp){ kb = 8.617333262145e-5 df = data.frame(x = x, temp = temp) df$logx = log(df$x) df$kbt = 1 / (kb * (df$temp + 273.15)) if(all(is.na(df$logx))) return(NA) return(-as.numeric(stats::coef(stats::lm(logx ~ kbt, data = df))['kbt'])) }
context("commands - set") test_that("SADD", { skip_if_cmd_unsupported("SADD") con <- test_hiredis_connection() key <- rand_str() on.exit(con$DEL(key)) expect_equal(con$SADD(key, "Hello"), 1) expect_equal(con$SADD(key, "World"), 1) expect_equal(con$SADD(key, "World"), 0) expect_equal(sort(unlist(con$SMEMBERS(key))), sort(c("Hello", "World"))) }) test_that("SCARD", { skip_if_cmd_unsupported("SCARD") con <- test_hiredis_connection() key <- rand_str() on.exit(con$DEL(key)) con$SADD(key, "Hello") con$SADD(key, "World") expect_equal(con$SCARD(key), 2) }) test_that("SDIFF", { skip_if_cmd_unsupported("SDIFF") con <- test_hiredis_connection() key1 <- rand_str() key2 <- rand_str() on.exit(con$DEL(c(key1, key2))) con$SADD(key1, "a") con$SADD(key1, "b") con$SADD(key1, "c") con$SADD(key2, "c") con$SADD(key2, "d") con$SADD(key2, "e") expect_equal(sort(unlist(con$SDIFF(c(key1, key2)))), sort(c("a", "b"))) }) test_that("SDIFFSTORE", { skip_if_cmd_unsupported("SDIFFSTORE") con <- test_hiredis_connection() key1 <- rand_str() key2 <- rand_str() key3 <- rand_str() on.exit(con$DEL(c(key1, key2, key3))) con$SADD(key1, "a") con$SADD(key1, "b") con$SADD(key1, "c") con$SADD(key2, "c") con$SADD(key2, "d") con$SADD(key2, "e") expect_equal(con$SDIFFSTORE(key3, c(key1, key2)), 2) expect_equal(sort(unlist(con$SMEMBERS(key3))), sort(c("a", "b"))) }) test_that("SINTER", { skip_if_cmd_unsupported("SINTER") con <- test_hiredis_connection() key1 <- rand_str() key2 <- rand_str() on.exit(con$DEL(c(key1, key2))) con$SADD(key1, "a") con$SADD(key1, "b") con$SADD(key1, "c") con$SADD(key2, "c") con$SADD(key2, "d") con$SADD(key2, "e") expect_equal(con$SINTER(c(key1, key2)), list("c")) }) test_that("SINTERSTORE", { skip_if_cmd_unsupported("SINTERSTORE") con <- test_hiredis_connection() key1 <- rand_str() key2 <- rand_str() key3 <- rand_str() on.exit(con$DEL(c(key1, key2, key3))) con$SADD(key1, "a") con$SADD(key1, "b") con$SADD(key1, "c") con$SADD(key2, "c") con$SADD(key2, "d") con$SADD(key2, "e") expect_equal(con$SINTERSTORE(key3, c(key1, key2)), 1) expect_equal(con$SMEMBERS(key3), list("c")) }) test_that("SISMEMBER", { skip_if_cmd_unsupported("SISMEMBER") con <- test_hiredis_connection() key <- rand_str() on.exit(con$DEL(key)) con$SADD(key, "one") expect_equal(con$SISMEMBER(key, "one"), 1) expect_equal(con$SISMEMBER(key, "two"), 0) }) test_that("SMEMBERS", { skip_if_cmd_unsupported("SMEMBERS") con <- test_hiredis_connection() key <- rand_str() on.exit(con$DEL(key)) con$SADD(key, "hello") con$SADD(key, "world") res <- con$SMEMBERS(key) expect_is(res, "list") expect_equal(sort(vcapply(res, identity)), sort(c("hello", "world"))) }) test_that("SMOVE", { skip_if_cmd_unsupported("SMOVE") con <- test_hiredis_connection() key1 <- rand_str() key2 <- rand_str() on.exit(con$DEL(c(key1, key2))) con$SADD(key1, "one") con$SADD(key1, "two") con$SADD(key2, "three") expect_equal(con$SMOVE(key1, key2, "two"), 1) expect_equal(con$SMEMBERS(key1), list("one")) expect_equal(sort(vcapply(con$SMEMBERS(key2), identity)), sort(c("two", "three"))) }) test_that("SPOP", { skip_if_cmd_unsupported("SPOP") con <- test_hiredis_connection() key <- rand_str() on.exit(con$DEL(key)) all <- c("one", "two", "three", "four", "five") con$SADD(key, all[[1]]) con$SADD(key, all[[2]]) con$SADD(key, all[[3]]) v <- con$SPOP(key) expect_true(v %in% all[1:3]) vals <- con$SMEMBERS(key) expect_equal(sort(vcapply(vals, identity)), sort(setdiff(all[1:3], v))) con$SADD(key, all[[4]]) con$SADD(key, all[[5]]) }) test_that("SRANDMEMBER", { skip_if_cmd_unsupported("SRANDMEMBER") con <- test_hiredis_connection() key <- rand_str() on.exit(con$DEL(key)) vals <- c("one", "two", "three") con$SADD(key, vals) expect_true(con$SRANDMEMBER(key) %in% vals) v <- vcapply(con$SRANDMEMBER(key, 2), identity) expect_equal(length(v), 2) expect_false(any(duplicated(v))) expect_true(all(v %in% vals)) v <- vcapply(con$SRANDMEMBER(key, -5), identity) expect_equal(length(v), 5) expect_true(any(duplicated(v))) expect_true(all(v %in% vals)) }) test_that("SREM", { skip_if_cmd_unsupported("SREM") con <- test_hiredis_connection() key <- rand_str() on.exit(con$DEL(key)) con$SADD(key, "one") con$SADD(key, "two") con$SADD(key, "three") expect_equal(con$SREM(key, "one"), 1) con$SADD(key, "four") expect_equal(sort(vcapply(con$SMEMBERS(key), identity)), sort(c("two", "three", "four"))) }) test_that("SUNION", { skip_if_cmd_unsupported("SUNION") con <- test_hiredis_connection() key1 <- rand_str() key2 <- rand_str() on.exit(con$DEL(c(key1, key2))) con$SADD(key1, "a") con$SADD(key1, "b") con$SADD(key1, "c") con$SADD(key2, "c") con$SADD(key2, "d") con$SADD(key2, "e") expect_equal(sort(vcapply(con$SUNION(c(key1, key2)), identity)), letters[1:5]) }) test_that("SUNIONSTORE", { skip_if_cmd_unsupported("SUNIONSTORE") con <- test_hiredis_connection() key1 <- rand_str() key2 <- rand_str() key3 <- rand_str() on.exit(con$DEL(c(key1, key2, key3))) con$SADD(key1, "a") con$SADD(key1, "b") con$SADD(key1, "c") con$SADD(key2, "c") con$SADD(key2, "d") con$SADD(key2, "e") expect_equal(con$SUNIONSTORE(key3, c(key1, key2)), 5) expect_equal(sort(vcapply(con$SMEMBERS(key3), identity)), letters[1:5]) })
library(testthat) library(timetk) library(tidyverse) library(tidyquant) library(forecast) library(robets) library(fracdiff) library(timeDate) library(tseries) test_check("timetk")
local_edition(3) mean_mat <- function(Mmin, Mmax){ Mmin <- statnet.common::NVL(Mmin, Mmax) Mmax <- statnet.common::NVL(Mmax, Mmin) matrix(ifelse(rbinom(length(Mmin), 1, .5), Mmin, Mmax), nrow(Mmin), ncol(Mmin)) } test_dind_constr <- function(y0, con, Mmin=NULL, Mmax=NULL, response=NULL, ...){ nn <- network.dyadcount(y0, FALSE) test_that(paste0("blockdiag constraint with constraint = ", format(con), ", and ", if(is.directed(y0)) "directed " else "undirected ", if(is.bipartite(y0)) "bipartite ", if(!is.null(response)) "valued ", "network"), { ymin <- simulate(statnet.common::NVL2(response, y0~sum, y0~edges), coef=-100, constraints=con, control=control.simulate.formula(MCMC.burnin=nn*100), response=response, ...) expect_true(all(na.omit(c(suppressWarnings(as.matrix(ymin, attrname=response))==Mmin)))) ymax <- simulate(statnet.common::NVL2(response, y0~sum, y0~edges), coef=+100, constraints=con, control=control.simulate.formula(MCMC.burnin=nn*100), response=response, ...) expect_true(all(na.omit(c(as.matrix(ymax, attrname=response)==Mmax)))) }) } n <- 10 m <- 7 a <- rep(1:4,1:4) Mmax <- Mmin <- matrix(0,n,n) for(i in unique(a)){ Mmax[a==i,a==i]<-1 } diag(Mmax)<-0 y0 <- as.network(mean_mat(Mmin,Mmax), matrix.type="adjacency", directed=TRUE) y0 %v% "b" <- a test_dind_constr(y0, ~blockdiag("b"), Mmin, Mmax) y0 <- as.network(mean_mat(Mmin,Mmax), matrix.type="adjacency", directed=FALSE) y0 %v% "b" <- a test_dind_constr(y0, ~blockdiag("b"), Mmin, Mmax) y0 <- as.network(mean_mat(Mmin,Mmax), matrix.type="adjacency", directed=TRUE) y0 %v% "b" <- a y0[2,3]<-NA y0[2,10]<-NA Mmin[2,10] <- Mmin[2,3] <- 0 Mmax[2,10] <- Mmax[2,3] <- 1 test_dind_constr(y0, ~blockdiag("b")-observed, Mmin, Mmax) Mmin <- Mmax <- as.matrix(y0) Mmin[2,3] <- 0 Mmax[2,3] <- 1 test_dind_constr(y0, ~blockdiag("b")+observed, Mmin, Mmax) a <- unlist(split(a, rep(1:2, n/2))) a <- c(sort(a[1:m]), sort(a[-(1:m)])) Mmin <- Mmax <- matrix(0,m,n-m) for(i in unique(a)){ Mmax[a[1:m]==i,a[-(1:m)]==i]<-1 } y0 <- as.network(mean_mat(Mmin,Mmax), matrix.type="adjacency", directed=FALSE, bipartite=m) y0 %v% "b" <- a test_dind_constr(y0, ~blockdiag("b"), Mmin, Mmax) y0[7,8]<-NA y0[6,9]<-NA Mmin[6,2] <- Mmin[7,1] <- 0 Mmax[6,2] <- Mmax[7,1] <- 1 test_dind_constr(y0, ~blockdiag("b")-observed, Mmin, Mmax) Mmin <- Mmax <- as.matrix(y0) Mmin[6,2] <- 0 Mmax[6,2] <- 1 test_dind_constr(y0, ~blockdiag("b")+observed, Mmin, Mmax) a1 <- rep(1:4,1:4) a2 <- rep(1:2,each=5) Mmin <- M1 <- M2 <- matrix(0,n,n) for(i in unique(a1)){ M1[a1==i,a1==i]<-1 } diag(M1)<-0 for(i in unique(a2)){ M2[a2==i,a2==i]<-1 } diag(M2)<-0 Mmax <- M1*M2 y0 <- as.network(mean_mat(Mmin,Mmax), matrix.type="adjacency", directed=FALSE) y0 %v% "b1" <- a1 y0 %v% "b2" <- a2 test_dind_constr(y0, ~blockdiag("b1") + blockdiag("b2"), Mmin, Mmax) a <- rep(1:4,1:4) Mmax <- Mmin <- matrix(0,n,n) for(i in unique(a)){ Mmax[a==i,a==i]<-4 } diag(Mmax)<-0 y0 <- as.network(mean_mat(Mmin,Mmax), matrix.type="adjacency", directed=TRUE, ignore.eval=FALSE, names.eval="w") y0 %v% "b" <- a test_dind_constr(y0, ~blockdiag("b"), Mmin, Mmax, response="w", reference=~DiscUnif(0,4))
ssfa <- function(formula, data = NULL, data_w = NULL, intercept = TRUE, pars = NULL, par_rho = TRUE, form = "cost") { mf <- model.frame(formula, data) y <- model.response(mf) x <- mf[-1] w <- as.matrix(data_w) tm <- attr(mf, "terms") intercept <- attr(tm, "intercept") == 1 if(!is.vector(y)) stop("y is not a vector") if(!is.data.frame(x)) stop("x is not a data frame") if(length(y) != nrow(x)) stop("x and y lengths differ") ssfa.fit(y = y, x = x, w=w, intercept = intercept, pars = pars, form=form, par_rho=par_rho) }
locationTest <- function(x, y, method = c("t", "kw2"), title = NULL, description = NULL) { method = match.arg(method) if (method == "t") { ans = .tTest(x, y, title = title, description = description) } if (method == "kw2") { ans = .kw2Test(x, y, title = title, description = description) } ans } .tTest <- function(x, y, title = NULL, description = NULL) { call = match.call() test = list() DNAME = paste(deparse(substitute(x)), "and", deparse(substitute(y))) test$data.name = DNAME x = as.vector(x) y = as.vector(y) two.sided = t.test(x = x, y = y, alternative = "two.sided", mu = 0, paired = FALSE, var.equal = FALSE, conf.level = 0.95) less = t.test(x = x, y = y, alternative = "less", mu = 0, paired = FALSE, var.equal = FALSE, conf.level = 0.95) greater = t.test(x = x, y = y, alternative = "greater", mu = 0, paired = FALSE, var.equal = FALSE, conf.level = 0.95) two.sided.equal = t.test(x = x, y = y, alternative = "two.sided", mu = 0, paired = FALSE, var.equal = TRUE, conf.level = 0.95) less.equal = t.test(x = x, y = y, alternative = "less", mu = 0, paired = FALSE, var.equal = TRUE, conf.level = 0.95) greater.equal = t.test(x = x, y = y, alternative = "greater", mu = 0, paired = FALSE, var.equal = TRUE, conf.level = 0.95) PARAMETER = c(length(x), length(y), 0) names(PARAMETER) = c( "x Observations", "y Observations", "mu") test$parameter = PARAMETER ESTIMATE = c(two.sided$estimate, var(x), var(y)) names(ESTIMATE) = c("Mean of x", "Mean of y", "Var of x", "Var of y") test$estimate = ESTIMATE PVAL = c( two.sided$p.value, less$p.value, greater$p.value, two.sided.equal$p.value, less.equal$p.value, greater.equal$p.value) names(PVAL) = c( "Alternative Two-Sided", "Alternative Less", "Alternative Greater", "Alternative Two-Sided | Equal Var", "Alternative Less | Equal Var", "Alternative Greater | Equal Var") test$p.value = PVAL STATISTIC = c( two.sided$statistic, two.sided.equal$statistic) names(STATISTIC) = c( " T", "T | Equal Var") test$statistic = STATISTIC CONF.INT = cbind( a = two.sided$conf.int, b = less$conf.int, c = greater$conf.int, d = two.sided.equal$conf.int, e = less.equal$conf.int, f = greater.equal$conf.int) dimnames(CONF.INT)[[2]] = c( "Two-Sided", " Less", " Greater", "Two-Sided | Equal Var", " Less | Equal Var", " Greater | Equal Var") test$conf.int = CONF.INT if (is.null(title)) title = "t Test" if (is.null(description)) description = date() new("fHTEST", call = call, data = list(x = x, y = y), test = test, title = as.character(title), description = as.character(description) ) } .kw2Test <- function(x, y, title = NULL, description = NULL) { call = match.call() test = list() DNAME = paste(deparse(substitute(x)), "and", deparse(substitute(y))) test$data.name = DNAME x = as.vector(x) y = as.vector(y) ESTIMATE = c(mean(x), mean(y), var(x), var(y)) names(ESTIMATE) = c("Mean of x", "Mean of y", "Var of x", "Var of y") test$estimate = ESTIMATE PARAMETER = c(length(x), length(y)) names(PARAMETER) = c( "x Observations", "y Observations") test$parameter = PARAMETER x = list(x = x, y = y) if (length(x) < 2) stop("x must be a list with at least 2 elements") k = length(x) l = sapply(x, "length") g = factor(rep(1 : k, l)) x = unlist(x) n = length(x) if (n < 2) stop("not enough observations") r = rank(x) TIES = table(x) STATISTIC = sum(tapply(r, g, "sum")^2 / tapply(r, g, "length")) STATISTIC = ((12 * STATISTIC / (n * (n + 1)) - 3 * (n + 1)) / (1 - sum(TIES^3 - TIES) / (n^3 - n))) names(STATISTIC) = "KW chi-squared" test$statistic = STATISTIC PVAL = 1 - pchisq(STATISTIC, 1) names(PVAL) = "" test$p.value = PVAL if(is.null(title)) title = "Kruskal-Wallis Two Sample Test" if(is.null(description)) description = date() new("fHTEST", call = call, data = list(x = x, y = y), test = test, title = as.character(title), description = as.character(description) ) }
getMu <- function(T, p.m) { M.x <- ifelse(T <= p.m["t1"], p.m["x1"], ifelse(T > p.m["t1"]+p.m["dt"], p.m["x2"], p.m["x1"] + (p.m["x2"] - p.m["x1"])/ p.m["dt"] * (T - p.m["t1"]))) M.y <- ifelse(T <= p.m["t1"], p.m["y1"], ifelse(T > p.m["t1"]+p.m["dt"], p.m["y2"], p.m["y1"] + (p.m["y2"] - p.m["y1"])/ p.m["dt"] * (T - p.m["t1"]))) return(cbind(x = M.x, y = M.y)) } getMu_multi <- function(T, p.m){ xs <- p.m[grep("x", names(p.m))] %>% as.vector ys <- p.m[grep("y", names(p.m))] %>% as.vector dt <- p.m[grep("dt", names(p.m))] %>% as.vector n.shifts <- length(xs) - 1 t.starts <- p.m[paste0("t",1:n.shifts)] %>% as.vector t.ends <- t.starts + dt breaks <- c(min(T) - 1,rowMeans(cbind(t.starts[-1], t.ends[-n.shifts])),max(T)) Mu <- matrix(nrow = length(T), ncol=2, dimnames = list(NULL, c("x","y"))) for(i in 1:n.shifts){ which <- which(T > breaks[i] & T <= breaks[i+1]) myp.m = c(t1 = t.starts[i], dt = dt[i], x1 = xs[i], y1 = ys[i], x2 = xs[i+1], y2 = ys[i+1]) Mu[which,] <- getMu(T[which], myp.m) } return(Mu) } getMu.return <- function(T, p.m){ x1 <- p.m['x1'] x2 <- p.m['x2'] x3 <- p.m['x1'] y1 <- p.m['y1'] y2 <- p.m['y2'] y3 <- p.m['y1'] t1 <- p.m['t1'] dt1 <- p.m['dt1'] t2 <- p.m['t2'] dt2 <- p.m['dt2'] M.x <- ifelse(T <= t1, x1, ifelse(T < t1+dt1, x1 + (x2 - x1)/dt1 * (T - t1), ifelse(T < t2, x2, ifelse(T < t2 + dt2, x2 + (x3 - x2)/dt2 * (T - t2), x3)))) M.y <- ifelse(T <= t1, y1, ifelse(T < t1+dt1, y1 + (y2 - y1)/dt1 * (T - t1 ), ifelse(T < t2, y2, ifelse(T < t2 + dt2, y2 + (y3 - y2)/dt2 * (T - t2), y3)))) return(cbind(x = M.x, y = M.y)) }