changeset 0:916b49d725ba draft

"planemo upload for repository https://github.com/Alanamosse/Galaxy-E/tree/stoctool/tools/stoc commit f82f897ab22464de40c878e17616333855814e25"
author ecology
date Thu, 02 Apr 2020 03:35:29 -0400
parents
children 5c244408661f
files FunctExeTemporalAnalysisofIndicatorTrait.r FunctTrendSTOCGalaxy.r coordCarreSTOCfaux.tabular species_indicateur_fonctionnel.tabular stoceps_macros.xml tabSpecies.csv temp_analysis_indic.xml
diffstat 7 files changed, 4942 insertions(+), 0 deletions(-) [+]
line wrap: on
line diff
--- /dev/null	Thu Jan 01 00:00:00 1970 +0000
+++ b/FunctExeTemporalAnalysisofIndicatorTrait.r	Thu Apr 02 03:35:29 2020 -0400
@@ -0,0 +1,328 @@
+#!/usr/bin/env Rscript
+
+########################################################################################################################################################################
+############## FUNCTION TO CALCULATE AND PLOT VARIATION IN TIME OF INDICATOR OR MEAN TRAIT VALUE OF COMMUNITIES  function:csi_cti_ctri    ##############################
+########################################################################################################################################################################
+
+#### Based on Romain Lorrillière R script
+#### Modified by Alan Amosse and Benjamin Yguel for integrating within Galaxy-E
+### made with R version 3.5.1
+
+
+suppressMessages(library(RODBC))  ##Version: 1.3-15
+suppressMessages(library(reshape))  ##Version: 0.8.8
+suppressMessages(library(data.table))  ##Version: 1.12.0
+suppressMessages(library(rgdal))  ##Version: 1.3-4
+suppressMessages(library(lubridate))  ##Version: 1.7.4
+#suppressMessages(library(RPostgreSQL))  ##Version: 0.6-2
+suppressMessages(library(doBy))  ##Version: 4.6-2
+suppressMessages(library(arm))  ##Version: 1.10-1
+suppressMessages(library(ggplot2))  ##Version: 3.1.0
+suppressMessages(library(scales))  ##Version: 1.0.0
+suppressMessages(library(mgcv))  ##Version: 1.8-24
+#suppressMessages(library(visreg))  ##Version: 2.5-0
+suppressMessages(library(plyr))  ##Version: 1.8.4
+#suppressMessages(library(lme4))  ##Version: 1.1-18-1
+#suppressMessages(library(lmerTest))  ##Version: 3.1-0
+suppressMessages(library(glmmTMB)) ###Version: 0.2.3
+
+
+###########
+#delcaration des arguments et variables/ declaring some variables and load arguments
+
+args = commandArgs(trailingOnly=TRUE)
+#for( i in 1:length(args)){print(args[i])}
+if (length(args)<12) {
+    stop("At least 12 arguments must be supplied :\n- An input dataset filtered (.tabular). May come from the filter rare species tool.\n- A species detail table (.tabular)\n- A species ssi/sti table.\n- A table with plots coordinates.\n- table with csi calculated before 2001.\n\n", call.=FALSE) #si pas d'arguments -> affiche erreur et quitte / if no args -> error and exit1
+} else {
+    Datafiltered<-args[1] ###### Nom du fichier avec extension ".typedefichier", peut provenir de la fonction "FiltreEspeceRare" / file name without the file type ".filetype", may result from the function "FiltreEspeceRare"    
+    tabSpecies<-args[2] ###### Nom du fichier avec extension ".typedefichier", fichier mis à disposition dans Galaxy-E avec specialisation à l'habitat des especes et si espece considérée comme indicatrice / file name without the file type ".filetype", file available in Galaxy-E containing habitat specialization for each species and whether or not they are considered as indicator  
+    tabtrait<-args[3] ##### Nom du fichier avec extension ".typedefichier", fichier mis à disposition dans Galaxy-E avec degre de specialisation de l espece et affinite thermique /file name without the file type ".filetype", file available in Galaxy-E containing specilalization degree as well as thermic preferences
+    coordCarre<-args[4] #### Nom du fichier avec extension ".typedefichier", fichier mis à disposition dans Galaxy-E avec les coordonnees gps des carres /file name without the file type ".filetype", file available in Galaxy-E containing gps coordinates of the plots
+    Var <- args[5] #### Nom du trait dans fichier de traits "nomdutrait" exemple: "ssi" pour l'indice de specialisation par sps / Name of the trait in the file containing trait data   
+    indicator <- args[6] #### Nom de l'indicateur ou du trait par communauté ex pour ssi c'est csi calculé au niveau communauté / Name of the indicator or the trait per community ex: for the ssi, it is the csi measured at the community level  
+    methode <- args[7] #### Methode d'analyse de l'evolution du trait ou de l'indicateur, lmer pour modèloe mixte seul ou gam pour generalized additive model / name of the models used to analyze evolution of mean trait or indicator
+    dd <- args[8] ##### Nom du fichier si déjà un fichier avec trait moyen par communauté, avec une colonne annee appelé "year" et une colonne plot appelé "carre" correspondant à l'echelle des communautés etudiées / name of the file if a file with the mean trait value per community is already prepared with one column named "year" for the year, one column named "carre" for the plots (the scale of the community measurment)
+    id<-args[9]#Id name for output res repo 
+    plot_smooth<-args[10]#TRUE or FALSE
+    ic<-args[11]#TRUE or FALSE
+    source(args[12])
+}
+
+#Import des données / Import data 
+tabCLEAN <- read.table(Datafiltered,sep="\t",dec=".",header=TRUE) #### charge le fichier de données d abondance / load abundance of species
+tabsp <- read.table(tabSpecies,sep="\t",dec=".",header=TRUE)   #### charge le fichier de donnees sur nom latin, vernaculaire et abbreviation, espece indicatrice ou non / load the file with information on species specialization and if species are indicators
+
+vars_tabCLEAN<-c("carre","annee","espece","abond")
+err_msg_tabCLEAN<-"The input dataset filtered doesn't have the right format. It need to have the following 4 variables :\n- carre\n- annee\n- espece\n- abond\n"
+
+vars_tabsp<-c("espece","nom","nomscientific","indicateur","specialisation")
+err_msg_tabsp<-"\nThe species dataset filtered doesn't have the right format. It need to have the following 4 variables :\n- espece\n- nom\n- nomscientific\n- indicateur\n- specialisation\n"
+
+check_file(tabCLEAN,err_msg_tabCLEAN,vars_tabCLEAN,4)
+check_file(tabsp,err_msg_tabsp,vars_tabsp,5)
+
+
+if(!dd==""){
+    vars_dd<-c("carre","year","longitude_grid_wgs84","latitude_grid_wgs84","indic")  #### si vous avez déjà votre tableau d'analyse indic correspond au trait moyen par communauté ou au calcul de l'indicateur
+    err_msg_dd<-"\nThe dataset for analysis doesn't have the right format. It need to have the following 5 variables :\n- carre\n- year\n- longitude_grid_wgs84\n- latitude_grid_wgs84\n- indic\n"
+    check_file(dd,err_msg_dd,vars_dd,5)
+    dd <- read.table(dd,sep="\t",dec=".",header=TRUE) #### charge le fichier pour analyse si déjà construit (voir ci dessus pour les détails ) / load the required file for the analysis if already prepared (see above for details)
+}else{
+    dd<-NULL
+}
+
+spTrait=read.table(tabtrait,sep="\t",dec=".",header=TRUE) ############# species_indicateur_fonctionnel.csv pour le STOC sinon fichier avec traits pour calcul du trait moyen par communauté / file with the trait for the community weighted mean calculation 
+coordCarre=read.table(coordCarre,sep="\t",dec=".",header=TRUE) ######## carre.csv  charge les coordonnées des carrés qui sont utilisés comme covariable  / load the gps coordinates of the plots, is used as covariable in the models
+
+dir.create(paste("Output/",sep=""),recursive=TRUE,showWarnings=FALSE)##### Creation du dossier de sortie
+#cat(paste("Create Output/","\n",sep=""))
+
+############################# The function
+
+
+csi_cti_ctri <- function(tabCLEAN=tabCLEAN,coordCarre=coordCarre,spTrait=spTrait,dd=NULL,ic=TRUE, Var="ssi",indicator="csi", methode="gam", ####### Var= nom du trait dans le fichier de trait (pour le calcul du csi, le trait est ssi par exemple); Indicator= nom de l'indicateur ou du trait moyen par communauté ; methode: choisir modele "gam" ou "glmmtmb" ; ic pour calcul de l'interval de confiance plus rapide sans mais moins fiable / Var=name of the trait in the trait file; Indicator= name of the indicator or of the community weighted mean trait used in graphical output and output files; methode is the statistical model use for the analysis "gam" or "glmmtmb" ; ic is for the calculation of confidence interval faster without but less reliable
+                          firstYear=NULL,lastYear=NULL,altitude=800,departement=NULL,onf=TRUE,distance_contact=NULL, #### altitude, departement onf, distance de contact = Argument non utilise, se trouvait dans requete sql / altitude, departement onf, distance de contact = not use anymore was in a postgres request
+                         spExcluPassage1=c("MOTFLA","SAXRUB","ANTPRA","OENOEN","PHYTRO"),# (Prince et al. 2013 Env. Sc. and Pol.) + "OENOEN","PHYTRO" avis d'expert F. Jiguet, #### Argument non utilise, se trouvait dans requete sql / not use anymore was in a postgres request
+                         seuilAbondance=.99,plot_smooth=TRUE, ###### init_1989 si TRUE, option que pour csi et besoin du fichier des csi calculés sur les données avant 2001 (pas forcement fiable car protocole un peu different) / init_1989 if TRUE, only working for csi, and use calculation of csi based on data before 2001 (protocol was bit different, not totally reliable)
+                          champSp = "code_sp", sp=NULL,champsHabitat=FALSE, #### Argument non utilise, se trouvait dans requete sql / not use anymore was in a postgres request
+                          anglais=FALSE,seuilSignif=0.05,##### #### anglais=FALSE Argument non utilise, se trouvait dans requete sql / not use anymore was in a postgres request
+                          couleur="#4444c3",
+                          titreY=indicator,titreX="Années",titre=indicator,
+                          savePostgres=FALSE,output=FALSE,   ##### OPTION "output" pour afficher le resultat dans R  / OPTION "output" is only to show the result in the R window 
+                          operateur=c("Lorrilliere Romain","lorrilliere@mnhn.fr"), encodingSave="ISO-8859-1",fileName="dataCSI",id="France"){ ####### nom des fichiers de sorties et de l'operateur / name of the output files and of the operator
+
+
+    start <- Sys.time()
+    dateExport <- format(start,"%Y-%m-%d")
+
+    if(is.null(firstYear)) firstYear <- 2001
+    if(is.null(lastYear)) lastYear <- 9999
+    if(is.null(altitude)) altitude <- 10000
+
+    #############################################  calcul de l'indicateur ou du trait moyen pondéré par communauté / Calculation of the weighted mean trait or of the indicator per community i.e. calculation of the csi, cti, ctri (corresponds to Community weighted mean or CWM for traits)
+    if (is.null(dd)){
+        colnames(spTrait)[colnames(spTrait) == Var] <- "trait"
+        spTrait$trait <- spTrait$trait
+        ###browser()
+        tabCLEAN$trait <- spTrait$trait[match(tabCLEAN$espece,spTrait$pk_species)] ### recupere donnee du trait par espece calcule  / retrieve trait data for each species 
+        tabCLEAN=na.omit(tabCLEAN) ##### pour faire les moyennes pondérées sur les espèces avec des données de trait (donc pas de prise en compte des sps sans traits dans l'abondance totale par carré)
+        traitcarre <- aggregate(trait*abond~annee+carre,tabCLEAN,sum) ### somme des traits par annee et carre pondere par les abondances / sum of the trait per year and per plots weighted by abundances
+        abcarre <- aggregate(abond~annee+carre,tabCLEAN,sum) ### somme des abondances totales par annee et carre / sum of total abundance per year and plots
+        indic <- traitcarre[,3]/abcarre[,3]  #### le trait moyen par carre = indicateur par carre et annee / mean trait per plots = indicator per year and plots
+        dd <- data.frame(indic,traitcarre$carre,traitcarre$annee) 
+        names(dd)[2] <- "carre"
+        names(dd)[3] <- "year"
+        dd$longitude_grid_wgs84 <- coordCarre$longitude_grid_wgs84[match(dd$carre,coordCarre$pk_carre)] #### recupere coordonnées gps / retrieve gps coordinates
+        dd$latitude_grid_wgs84 <- coordCarre$latitude_grid_wgs84[match(dd$carre,coordCarre$pk_carre)]  #### recupere coordonnées gps / retrieve gps coordinates
+        dd$id_plot <- dd$carre  ### id_plot nom données aux carrés dans le script /id_plot is use as the name of the plot in the following script
+    }else{
+        colnames(dd)[colnames == "indicator"] <- "indic"
+    }
+
+    ############################################ fin du calcul de l'indicateur ou du trait moyen pondéré par communauté / end of the calculation of the indicator or the mean trait value per community
+    annee <- sort(unique(dd$year))
+    nban <- length(annee)
+    pasdetemps <-nban-1
+
+    if(methode == "gam") {
+        cat("Methode: gam\n")
+        ## Utilisation des modèles GAMM pour obtenir les tendances d evolution par an du csi cti ou ctri !!!! Marche pas si peu de données !!!!  / Use of GAMM model for the estimation of the annual variations of the csi cti or ctri  !!! does not work with few data !!! 
+        cat("\nEstimation de la variation annuelle ",indicator,"~ factor(year)+s(longitude_grid_wgs84,latitude_grid_wgs84,bs='sos'),random=reStruct(object = ~ 1| id_plot,correlation=corAR1(form=~year)\n",sep="")
+        gammf <- gamm(indic ~ factor(year)+s(longitude_grid_wgs84,latitude_grid_wgs84,bs="sos"), data=dd,random=reStruct(object = ~ 1| id_plot, pdClass="pdDiag"),correlation=corAR1(form=~year)) #### spline sur les coordonnées, effet aleatoire sur les carres, methode autoregressive sur l'année N-1  / spline on the gps coordinates, random effect on the plots, autoregressive method on the year-1  
+#        gammf <- gamm(indic ~ factor(year)+s(longitude_grid_wgs84,latitude_grid_wgs84,bs="sos"), data=dd,random=reStruct(object = ~ 1| id_plot, pdClass="pdDiag"),correlation=corAR1(form=~year)) #### spline sur les coordonnées, effet aleatoire sur les carres, methode autoregressive sur l'année N-1  / spline on the gps coordinates, random effect on the plots, autoregressive method on the year-1 
+        sgammf<-summary(gammf$gam)
+        coefdata=coefficients(gammf$gam) ### recupere les coefficient de regression de la variable "annee" / retrieve the regression coefficient of the variable "year"
+        coefannee <- c(0,sgammf$p.coeff[2:nban])  ### meme chose que au dessus / same as before
+        erreuran <- c(0,sgammf$se[2:nban])### recupere les erreurs standard des coefficient de regression de la variable "annee" / retrieve the standard errors of the regression coefficient of the variable "year"
+        pval <-  c(1,sgammf$p.pv[2:nban])### recupere les p value de la variable "annee" / retrieve the p value of the variable year
+           
+
+        ## calcul des intervalles de confiance  / confidence interval calculation
+        if(ic) {
+            # gammf.sim <- sim(gammf)  ######################  VERSION ROMAIN mais fct sim() ne marche pas avec GAMM / old version using function sim() but did not work with Gamm models
+            # ic_inf_sim <- c(0,tail(apply(coef(gammf.sim), 2, quantile,.025),pasdetemps))
+            # ic_sup_sim <- c(0,tail(apply(coef(gammf.sim), 2, quantile,.975),pasdetemps))
+            icalpha05 <- as.data.frame(confint(gammf$gam))[2:nban,1:2]  ########## VERSION BENJ 
+            ic_inf_sim <- icalpha05[,1]
+            ic_inf_sim <- c("NA",ic_inf_sim[1:nban-1])
+            ic_sup_sim <- icalpha05[,2]
+            ic_sup_sim <- c("NA",ic_sup_sim[1:nban-1])
+        } else{
+            ic_inf_sim <- "not assessed"
+            ic_sup_sim <- "not assessed"
+        }
+
+        tabfgamm <- data.frame(model = "gamm factor(year) plot",annee,coef=coefannee,se = erreuran,pval,signif=pval<seuilSignif,Lower_ci=ic_inf_sim,upper_ci=ic_sup_sim,indicator=indicator) #### recupère les resultats des modèles avec interval de confiance / retrieve results of the models used with confidence interval 
+        write.table(tabfgamm,paste("Output/",indicator,"_gammParannee_",id,".tabular",sep=""),row.names=FALSE,sep="\t") 
+        gg <- ggplot(data=tabfgamm,aes(x=annee,y=coef))
+        gg= gg + geom_line(size=1.5,colour=couleur)+ geom_point(size=3,colour=couleur) +  geom_point(size=1.5,colour="white")
+
+        if (ic){       
+            gg <- gg + geom_errorbar(aes(ymin=coef-se, ymax=coef+se), width=0,colour=couleur,alpha=0.5) 
+            gg <- gg + geom_ribbon(aes(ymin=coef-se, ymax=coef+se),fill = couleur,alpha=.2)
+        }
+        gg <- gg + labs(y=indicator,x="annee")+scale_x_continuous(breaks=pretty_breaks())
+        ggsave(paste("Output/fig",indicator,"_carre_",id,".png",sep=""),gg)
+
+
+        if(plot_smooth) {   #### Representation graphique de l'evolution annuelle des indicateurs  / Graphical representation of the annual evolution of the indicators
+            cat("\nGam pour la figure ",indicator,"~s(year),random=reStruct(object = ~ 1| id_plot,correlation=corAR1(form=~year)\n",sep="")
+            ## create a sequence of temperature that spans your temperature  #####not use anymore 
+            ## http://zevross.com/blog/2014/09/15/recreate-the-gam-partial-regression-smooth-plots-from-r-package-mgcv-with-a-little-style/  #### method for the plot
+            ####dd$yearf=factor(dd$year) PAS BON j'ai modifié la ligne suivante en mettant s(year) et plus s(yearsf)
+            gammgg <- gamm(indic ~ s(year), data=dd,random=reStruct(object = ~ 1| id_plot, pdClass="pdDiag"),correlation=corAR1(form=~year))  #### spline sur l'année, effet aleatoire des carres sur ordonnée à l'origine, methode autoregressive sur l'année N-1  / spline on the year, random effect of the plots on the intercept, autoregressive method on the year-1 
+            maxyear<-max(dd$year)
+            minyear<-min(dd$year)
+            year.seq<-sort(unique(c(minyear:maxyear,(seq(minyear, maxyear,length=1000)))))
+            year.seq<-data.frame(year=year.seq)
+            # predict only the temperature term (the sum of the   ########### ???? not use anymore
+            # term predictions and the intercept gives you the overall########### ???? not use anymore
+            # prediction)########### ???? not use anymore
+            preds<-predict(gammgg$gam, newdata=year.seq, type="terms", se.fit=TRUE)  #### Utilise model pour predire les valeurs de indic sur sequence d'années defini au dessus \ Use of the model to predict value of the indicator in the year sequence define above
+            # set up the temperature, the fit and the upper and lower########### ???? not use anymore
+            # confidence interval########### ???? not use anymore
+            year <-year.seq$year
+            realYear <- sort(unique(dd$year))
+            fit<-as.vector(preds$fit)
+            init <- fit[1]
+            fit.up95 <- fit-1.96*as.vector(preds$se.fit)    
+            fit.low95 <- fit+1.96*as.vector(preds$se.fit)
+            # ggGamData <- data.frame(year=year, csi=fit,ic_low95 = fit.low95, ic_up95 = fit.up95)
+            fit <- fit - init ### Réechelonne les predictions du modèle sur la 1ère valeure de la prediction  ? ne sait pas pourquoi
+            fit.up95 <- fit.up95 - init  ### Réechelonne IC superieur sur la 1ère valeure de la prediction  ? ne sait pas pourquoi
+            fit.low95 <- fit.low95 - init  ### Réechelonne IC inferieur sur la 1ère valeure de la prediction  ? ne sait pas pourquoi
+            ggGamData <- data.frame(year=year, indic=fit,ic_low95 = fit.low95, ic_up95 = fit.up95)  ####### Recupère les resultats des modèles / retrieve the results of the models 
+   
+
+            ## The ggplot:
+            gg <- ggplot(data=ggGamData,aes(x=year,y=indic))+ geom_line(size=1,colour=couleur)
+            if (ic) {
+                gg <- gg + geom_ribbon(aes(ymin=ic_low95, ymax=ic_up95),fill = couleur,alpha=.2)
+            }
+            gg <- gg +  geom_point(data = subset(ggGamData,year %in% realYear),size=3,colour=couleur) + geom_point(data = subset(ggGamData,year %in% realYear),size=1.5,colour="white")
+            gg <- gg + labs(y=titreY,x=titreX,title=titre)+scale_x_continuous(breaks=pretty_breaks())
+            ggsave(paste("Output/fig",indicator,"_plot",id,".png",sep=""),gg)
+            #cat("\n--> Output/fig",indicator,"_plot",id,".png\n",sep="")
+
+            tabPredict <- subset(ggGamData,year %in% realYear)########### Tableau des resultats pour ne prendre que les valeurs d'IC pour l'année pas entre les années (spline sur annee) !!!plus utilisé!! / Table of the results not taking confidence interval between year but at each year (because of the spline of year)
+            colnames(tabPredict)[1:2] <- c("annee",paste(indicator,"_predict",sep=""))
+            tabgamm <- merge(tabfgamm,tabPredict,by="annee") #### Desactivation car merge sortie de modèles différents (le modèle dont on tire les coef de regression pour année, avec spli ne sur les coordonnées geo vs celui pour faire la figure avec splin sur année uniquement)  / not use anymore (as before) because use the results of the restricted model with the spline on the year while the better analysis is on full model with the spline on gps coordinates
+            ##tabgamm <-  tabfgamm  #### remplace la ligne au dessus  / replace the line above
+            write.table(tabPredict,paste("Output/",indicator,"_gammsmooth",id,".tabular",sep=""),row.names=FALSE,sep="\t")
+        }else {
+            tabgamm = tabfgamm
+        }
+        ###### CROCHET deplacer apres le dernier ggplot ici mais dans version Romain CROCHET placé AVANT le dernier ggplot qui n'était pas dans la condition if(init_1989)
+        cat("\nEstimation de la tendence  ",indicator,"~ year+s(longitude_grid_wgs84,latitude_grid_wgs84,bs='sos'),random=reStruct(object = ~ 1| id_plot,correlation=corAR1(form=~year)\n")
+        gammc <- gamm(indic~year+s(longitude_grid_wgs84,latitude_grid_wgs84,bs="sos"), data=dd,random=reStruct(object = ~ 1| id_plot, pdClass="pdDiag"),correlation=corAR1(form=~year))### spline sur les coordonnées, effet aleatoire des carres sur ordonnée à l'origine, methode autoregressive sur l'année N-1  / spline on the gps coordinates, random effect of the plots on intercept, autoregressive method on the year-1
+        sgammc=summary(gammc$gam)
+        coefannee <- sgammc$p.coeff[2]  #### coefficient de regression de la variable année / regression coefficient of the variable "year"
+        ## erreur standard / standard error
+        erreuran <- sgammc$se[2]
+        ## p value
+        pval <-  sgammc$p.pv[2]
+
+        #### Calcul des intervalles de confiances / calculation of the confidence intervals
+        if(ic) {
+            # gammc.sim <- sim(gammc)######################  VERSION ROMAIN mais fct sim() marche pas avec Gamm / old version using function sim() but did not work with Gamm models
+            # ic_inf_sim <- c(0,tail(apply(coef(gammc.sim), 2, quantile,.025),pasdetemps))
+            # ic_sup_sim <- c(0,tail(apply(coef(gammc.sim), 2, quantile,.975),pasdetemps))
+            icalpha052 <- as.data.frame(confint(gammc$gam))[2,1:2]  ########## VERSION BENJ
+            ic_inf_sim2 <- icalpha052[,1]
+            ic_sup_sim2 <- icalpha052[,2]
+        } else{
+            ic_inf_sim2 <- "not assessed"
+            ic_sup_sim2 <- "not assessed"
+        }
+        tabcgamm <- data.frame(model = "gamm numeric(year) plot",annee = NA,coef = coefannee,se = erreuran,pval,signif = pval<seuilSignif, indicator= indicator , Lower_ci = as.factor(ic_inf_sim2), upper_ci = as.factor(ic_sup_sim2), csi_predict =NA ,ic_low95 =NA,ic_up95=NA)#### recupère les resultats des modèles avec interval de confiance / retrieve results of the models used with confidence interval
+        ########### MODIF tabcgamm en remplacant ic_low95 ic_up95 par Lower_ci et upper_ci pour coller avec les sorties des modèles "pour les stats" et non celui utilisé pour le graphe uniquement, et rajout des colonnes spécifique a model ggsmooth pour les garder
+#### ai rajouté aussi as.factor(ic) car ne savait pas pourquoi mais tabfgamm sont en facteur et besoin de la meme class pour rbind() ci dessous
+        tabcgamm <- tabcgamm[,colnames(tabgamm)]  ##
+        tabgamm <- tabgamm[,colnames(tabcgamm)]  #### recupère que les colonnes de tabcgamm donc perds les infos du modèle du ggsmooth si pas declarer dans le tableau tabcgamm (maintenant c fait)
+        tabgamm <- rbind(tabgamm,tabcgamm)
+        write.table(tabgamm,paste("Output/",indicator,"_gammCOMPLET_",id,".tabular",sep=""),row.names=FALSE,sep="\t")
+        #cat("\n  --> Output/",indicator,"_gammPlot_",id,".tabular\n",sep="")
+    }
+
+    
+    if (methode == "glmmtmb") {
+        #cat("Method : lmer \n")
+        cat("Method : glmmTMB \n")
+        ###################
+        ### Utilisation des modèles mixtes pour obtenir les tendances d evolution par an du csi cti ou ctri / Use of mixte model for the estimation of the annual variations of the csi cti or ctri 
+        #cat("\nEstimation de la variation annuelle lmer(",indicator,"~ factor(year)+(1|id_plot)\n",sep="")
+        cat("\nEstimation de la variation annuelle glmmTMB(",indicator,"~ factor(year)+(1|id_plot)\n",sep="")
+        #md.f <- lmer(indic~ factor(year)+(1|id_plot),data=dd)  ##### effet aleatoire liés aux carrés sur l'ordonnée à l'origine / random effects of plots on intercept 
+        md.f <- glmmTMB(indic~ factor(year)+(1|id_plot),data=dd) 
+        smd.f <- summary(md.f)    
+        # coefdata.f <-  as.data.frame(smd.f$coefficients)  ### version pour sortie lmer()
+        coefdata.f <-  as.data.frame(smd.f$coefficients$cond[-1,])
+        coefdata.f <- data.frame(model="Annual fluctuation", variable = rownames(coefdata.f),coefdata.f)
+        # ggdata <<- data.frame(year=c(as.numeric(substr(coefdata.f$variable[-1],13,16))),##### version pour sortie lmer()
+        ggdata <- data.frame(year=c(as.numeric(substr(coefdata.f$variable,13,17))),             
+        estimate=c(coefdata.f$Estimate),
+        se=c(coefdata.f$Std..Error))   #####################  resultat du modèle / results of the models
+        #ggdata$estimate <-  ggdata$estimate
+        #ggdata$se.supR <- ggdata$estimate +  ggdata$se ############################################################################## METHODE ROMAIN 
+        #ggdata$se.infR <- ggdata$estimate -  ggdata$se
+        # ggdata$estimate2 <- c(coefdata.f$Estimate[1],coefdata.f$Estimate[1] + coefdata.f$Estimate[-1])
+        # ggdata$se.sup2 <- ggdata$estimate2 +  ggdata$se
+        # ggdata$se.inf2 <- ggdata$estimate2 -  ggdata$se
+        #prof <- profile(md.f)  #### Nouvel interval de confiance avec utilisation du logarithme des ecarts types / logarithms of standard deviations are used, while varianceProf converts from the standard-deviation to the variance scale
+        MODconfint <- confint (md.f) #### plus rapide de ne pas passer par la fonction profile et pas indispensable fonctionne aussi directement sur modele mixte md.f  / more rapid using both function profile and confint but works also directly on output of the model 
+        se.sup <- MODconfint[2:nban,2]#### [2:nban+2,2] version pour sortie lmer()
+        se.inf <- MODconfint[2:nban,1]#### [2:nban+2,2] version pour sortie lmer()
+        if (ic) {
+            ggdata$se.sup <- se.sup 
+            ggdata$se.inf <- se.inf
+        } else{
+            ggdata$se.sup <- "not assessed"
+            ggdata$se.inf <- "not assessed"
+        }
+        coefdata.f$se.inf <- ggdata$se.inf
+        coefdata.f$se.sup <- ggdata$se.sup
+        #gg <<- ggplot(ggdata,aes(x=year,y=estimate))+ geom_ribbon(ymin=ggdata$se.infR,ymax=ggdata$se.supR,alpha=.25)+geom_errorbar(ymin=ggdata$se.infR,ymax=ggdata$se.supR,width=0,alpha=.25)+ geom_point() + geom_line() + ylim(min(ggdata$se.infR),max(ggdata$se.supR)) + labs(x="Years",y=paste(indic," variation",sep="")) #####  AVEC INTERVAL ROMAIN
+        gg <- ggplot(ggdata,aes(x=year,y=estimate))+ geom_point() + geom_line()  + labs(x="Years",y=paste(indicator," variation",sep="")) #####+ ylim(min(ggdata$se.inf),max(ggdata$se.sup))
+        gg <- gg + geom_line(size=1.5,colour=couleur)+ geom_point(size=3,colour=couleur) +  geom_point(size=1.5,colour="white")
+        if (ic)	{
+            gg <- gg + geom_ribbon(aes(ymin=ggdata$se.inf,ymax=ggdata$se.sup),alpha=.25,fill = couleur) + geom_errorbar(ymin=ggdata$se.inf,ymax=ggdata$se.sup,width=0,alpha=.25)
+        }
+        ggfile <- paste("Output/",indicator,"_glmmTMB_",id,".png",sep="")
+        ggsave(ggfile,gg)
+
+        ############ Estimation de la tendance sur la periode étudiée  / Trends estimation on the time period studied
+        #cat("\nEstimation de la tendance lmer(",indicator,"~ year+(1|id_plot)\n",sep="")
+        cat("\nEstimation de la tendance glmmTMB(",indicator,"~ year+(1|id_plot)\n",sep="")
+        #md.c <- lmer(indic~ year+(1|id_plot),data=dd)##### effet aleatoire liés aux carrés sur l'ordonnée à l'origine / random effects of plots on intercept ### version lmer
+        md.c <- glmmTMB(indic~ year+(1|id_plot),data=dd)
+        smd.c<-summary(md.c)
+        # coefdata.c <-  as.data.frame(smd.c$coefficients) #### pour la version lmer
+        coefdata.c <-  as.data.frame(smd.c$coefficients$cond)[2,]
+        #profc=profile(md.c) ######### Ajout des intervalles de confiances / addition of the confidence intervals
+        if (ic) {
+            MODconfint=confint(md.c) ### plus rapide de ne pas passer par profile
+            se.inf=MODconfint[2,1]### [4,1] pour la version lmer
+            se.sup=MODconfint[2,2]### [4,2] pour la version lmer
+        } else{
+            se.inf <- "not assessed"
+            se.sup <- "not assessed"
+        }
+        coefdata.c <- data.frame(model = "Linear trend", variable = rownames(coefdata.c),coefdata.c,se.inf,se.sup)
+        coefdata <- rbind(coefdata.c,coefdata.f)
+        write.table(coefdata,paste("Output/GlmmTMB_coefficient_",indicator,id,".tabular",sep=""),row.names=FALSE,sep="\t")
+        write.table(ggdata,paste("Output/ggdata_",indicator,id,".tabular",sep=""),row.names=FALSE,sep="\t")
+        smd.file <- paste("Output/summary_lmer_",indicator,"_",id,".txt",sep="")
+        #####################
+    }
+}
+
+
+
+
+
+################## 
+###  Do your analysis
+
+csi_cti_ctri(tabCLEAN=tabCLEAN,coordCarre=coordCarre,spTrait=spTrait,dd=NULL,Var=Var,indicator=indicator,ic=ic,plot_smooth = plot_smooth,methode=methode)#,init_1989 = FALSE)  ##### exemple pour l'indicateur csi sans csi déjà calculé donc à partir du ssi avec interval de confiance et utilisant modele mixte / example for the csi index which is not already calculated from the ssi with confidence interval using the mixte model 
+
--- /dev/null	Thu Jan 01 00:00:00 1970 +0000
+++ b/FunctTrendSTOCGalaxy.r	Thu Apr 02 03:35:29 2020 -0400
@@ -0,0 +1,776 @@
+#!/usr/bin/env Rscript
+
+
+##################################################################################################################################
+############## FUNCTION TO CALCULATE AND PLOT EVOLUTION OF SPECIES POPULATION  function:main.glm    ##############################
+##################################################################################################################################
+
+#### Based on Romain Lorrillière R script
+#### Modified by Alan Amosse and Benjamin Yguel for integrating within Galaxy-E
+
+##### workes with the R version 3.5.1 (2018-07-02)
+##### Package used with the version:
+#suppressMessages(library(lme4))  version 1.1.18.1
+#suppressMessages(library(ggplot2))  version 3.0.0
+#suppressMessages(library(speedglm))  version 0.3.2
+#suppressMessages(library(arm))  version 1.10.1
+#suppressMessages(library(reshape))  version 0.8.8
+#suppressMessages(library(data.table))  version 1.12.0
+#suppressMessages(library(reshape2))   version 1.4.3
+
+
+
+######################################### debut de la fonction makeTableAnalyse / stard of the function makeTableAnalyse
+## mise en colonne des especes  et rajout de zero mais sur la base des carrés selectionné sans l'import  /  Species are placed in separated columns and addition of zero on plots where at least one selected species is present 
+
+makeTableAnalyse <- function(data) {
+    tab <- reshape(data
+                  ,v.names="abond"
+                  ,idvar=c("carre","annee")      
+                  ,timevar="espece"
+                  ,direction="wide")
+    tab[is.na(tab)] <- 0               ###### remplace les na par des 0 / replace NAs by 0 
+
+    colnames(tab) <- sub("abond.","",colnames(tab))### remplace le premier pattern "abond." par le second "" / replace the column names "abond." by ""
+    return(tab)
+}
+
+######################################### fin de la fonction makeTableAnalyse / end of the function makeTableAnalyse
+
+
+
+
+
+############################################# les fonctions qui filtrent les données pas suffisantes pour analyses fiables / The filtering functions removing species with not enough data to perform accurate analyses
+
+filter_absent_species<-function(tab){
+##################### Filtre les espèces jamais présentes (abondance=0) / Filter of species with 0 abundance
+#################################################################################  PARTIE POTENTIELLEMENT ISOLABLE ET INSERABLE AVANT LA BOUCLE = permet de gagner du temps sur la boucle car supprime sps pas vu, donc pas repris par la boucle
+    
+    ## Fait la somme des abondances totales par espèce / calculate the sum of all abundance per species
+    if(ncol(tab)==3) {
+	tabSum <- sum(tab[,3])## cas d'une seule especes (problème de format et manip un peu differente)  / when selecting only one species, use a different method
+	names(tabSum) <- colnames(tab)[3]
+    } else {  ## cas de plusieurs espèce/ when selecting more than one species
+        tabSum <- colSums(tab[,-(1:2)])
+    }
+    ## colNull= espece(s) toujours absente /species with 0 total abundance
+    colNull <- names(which(tabSum==0))
+    ## colconserve= espece(s) au moins presente 1 fois/ species at least with 1 presence
+    colConserve <- names(which(tabSum>0))
+    ## Affichage des espèces rejetees  / show species eliminated for the analyses
+    if(length(colNull)>0){
+        cat("\n",length(colNull)," Species removed from the analysis, abundance is always 0.\n\n",sep="")  #Espèces enlevées de l'analyse car abondance toujours égale a 0\n\n",sep="")
+        #tabNull <- data.frame(Code_espece = colNull, nom_espece = tabsp[colNull,"nom"])
+        #cat("\n\n",sep="")
+        tab <- tab[,c("carre","annee",colConserve)]
+    }
+################################################################################ FIN DE LA PARTIE ISOLABLE
+    return(tab)  
+}
+
+
+
+
+###################### Filtre les especes trop rare pour avoir des analyses robustes i.e. espèce non presente la 1ère année, avec plus de 3 ans consecutif sans données et moins de 3 ans consécutif avec données 
+######################  Filter too rare species for accurate analysis i.e.  species absent the first year, with more than 3 consecutive years with 0 abundance, or with less than 3 consecutive years with presence
+
+###
+filter_rare_species<-function(tab){ 
+    exclude_threshold <- NULL
+    ## calcul et filtre pour chaque (colonne) espece / measure and filter for each species
+    for(i in 3:ncol(tab)) {
+        ## v =abondance par annee / v= abundance per year
+        v <- tapply(tab[,i],tab$annee,sum)  ####################    
+        ## v0 =presence(1) abscence(0) per year 
+        v0 <- ifelse(v>0,1,0)  ##### 
+        tx <- paste(v0,collapse="") #### colle les 0 et 1 / stick the 0 and 1 
+        
+        p <- unlist(strsplit(tx,"0"))#### Enleve les 0, ce qui séparent les sequences de "1", les sequences de "1" = nbre d'années consécutives avec data / remove 0, splitting sequences of "1" which correspond to consecutve year with data (e.g. 111 = 3 years consecutive years with data)
+        p <- p[p!=""] #### ne garde pas les partie sans 1 ou 0 dans les sequences
+        ## gsSup0 = plus grande serie temporelle de presence =calcul du nbre de 1 consécutif max / calcul of the biggest temporal series which corresponds to the maximum number of consecutive "1"
+        gsSup0 <- max(nchar(p))#### 
+        ## gsInf0 plus grande serie temporelle d'absccence ou sans données = enlève les 1 séparant sequence de 0 qui correspondent au nbre d'année consecutive sans données / calcul of the biggest temporal series without data which corresponds to max numbzer fo consecutive "0" 
+        gsInf0 <- max(nchar(unlist(strsplit(tx,"1")))) ####  
+        ## y0is0 absence la premiere annee
+        y0is0 <- v0[1]==0  #### True ou false pour presence de "0"(=pas de données) dans la 1ère année / look if the first year of the time sequence analyzed has no data 
+        ## seuil d'exclusion / exclusion threshold  
+        exclude_threshold <- c(exclude_threshold,as.vector(ifelse( y0is0 | gsInf0 > 3 | gsSup0 < 3 ,"exclu","bon")))  ############## exclu sps absente la 1ère année, avec plus de 3 ans consécutifs sans données, et avec moins de 3 années consécutives sans données / indicate if the max consecutive year with data and without data, as well as whether the first year of the time sequence analyzed has data 
+    }
+    names(exclude_threshold) <- colnames(tab)[3:ncol(tab)]
+
+    ## colonnes conservees avec assez de données / Column with enough data
+    colConserve <- names(exclude_threshold)[exclude_threshold=="bon"]
+    
+  
+    ## colonnes supprimees / Column that will conserved 
+    colSupr <- names(exclude_threshold)[exclude_threshold=="exclu"]
+    tabCLEAN <- tab[,c("carre","annee",colConserve)] #### Garde les sps à conserver / select only species with enough data 
+    lfiltre <- list(tabCLEAN=tabCLEAN,colConserve=colConserve,colSupr=colSupr)
+     
+################################################################################# 
+
+    ## colConserve espece conservees / extract species that will be kept to print them
+    colConserve <- lfiltre$colConserve
+    ## colsupr espece trop rare et donc supprimée de l'analyse / extract species that will be deleted to print them
+    colSupr <- lfiltre$colSupr
+    ## affichage des especes retirer de l'analyse / print species that will be deleted
+    if(length(colSupr)>0){
+        cat("\n",length(colSupr)," Rare species removed from the analysis.\n\n",sep="")
+        #tabSupr <- subset(tabsp,espece %in% colSupr ,select=c("espece","nom"))
+        #tabSupr <- tabSupr[order(tabSupr$espece),]
+        #cat("\n\n",sep="")
+        
+    }
+    if(length(colConserve)==0) {
+        mess <- "No species available to calculate abundance variation in this dataset."
+        stop(mess)
+    }
+	
+    tabCLEAN <- lfiltre$tabCLEAN
+
+                                        #### MARCHE PAS NE SAIT PAS PQUOI
+    tabCLEAN <- melt(tabCLEAN, id.vars=c("carre", "annee"))  #### remet le format de base :le nom d'espèce et abondance dans des colonnes séparées / back to the first format of the file: species name and abundance in separated column
+    
+    colnames(tabCLEAN)[3:4] <- c("espece","abond")
+    tabCLEAN$annee <- as.numeric(as.character(tabCLEAN$annee))
+################################################################################ 
+    return(tabCLEAN)
+}
+
+####################################################################################################################### fin des 2 fonctions de filtre des données / end of the two function to filter the data
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+############################################################################################ debut de la Function main.glm / start of the function main.glm
+
+main.glm <- function(id="france",donneesAll=dataCLEAN,assessIC= TRUE,tabsp=tabsp,annees=annees,figure=TRUE,description=TRUE,tendanceSurFigure=TRUE, ###### declaration des arguments  listSp=sp était avant declaré avant la fonction mais il me semble que ca marche aussi comme cela
+                     seuilOccu=14,seuilAbond=NA) {
+
+    
+
+    filesaveAn <-  paste("Output/",id,"/variationsAnnuellesEspece_",id,".tabular",  ##### Nom du dossier ET fichier de sortie des resultats par année / name of the output file with results for each years
+                         sep = "")
+    filesaveTrend <-  paste("Output/",id,"/tendanceGlobalEspece_",id,".tabular",   ##### Nom du dossier ET fichier de sortie des resultats pour la période "annee" complete / name of the output file with the results for the period
+                            sep = "")
+    fileSaveGLMs <-  paste("Output/",id,"/listGLM_",id,sep = "")  #####  Nom du dossier ET fichier de sortie des modèles lineaire generalisés / name of the output file of the generlized linear models
+
+
+    
+     
+    seuilSignif <- 0.05  ## seuil de significativite / significancy threshold
+    
+    
+   rownames(tabsp) <- tabsp$espece  ## change nom des lignes de tabsp (table de reference des especes) 
+    
+    
+    ##vpan vecteur des panels de la figure  ###### POUR FAIRE LES GRAPHIQUES
+    vpan <- c("Variation abondance")
+    if(description) vpan <- c(vpan,"Occurrences","Abondances brutes")
+                                        
+
+    ## specifications des variables temporelles necesaires pour les analyses / specification of temporal variable necessary for the analyses
+    annee <- sort(unique(donneesAll$annee))
+    nbans <- length(annee)
+    pasdetemps <- nbans-1
+    firstY <- min(annee)
+    lastY <- max(annee)
+	
+	
+	
+	
+
+    ## Ordre de traitement des especes ### order of species to be analyzed
+    spOrdre <- aggregate(abond~espece,data=donneesAll,sum)  #### calcul les sommes des abondances pour ordonner / calculate the sum for the ordination
+    spOrdre <- merge(spOrdre,tabsp,by="espece") #### rajoute la colonne avec les abondances totales par espece / add a new column with the sum
+    
+    spOrdre <- spOrdre[order(as.numeric(spOrdre$indicateur),spOrdre$abond,decreasing = TRUE),] #### mets les especes plus abondantes en premiers (plus long pour faire tourner le modèle) / order the species by abundance, the most abundant species being the less fast analysis
+    
+    
+    listSp <- spOrdre$espece
+    i <- 0
+    nbSp <- length(listSp)
+                                        #	browser()
+    ## analyse par espece
+### browser()
+    ## affichage des especes conservees pour l'analyse  ### PAS SUR QUE CE SOIT ENCORE UTILE
+    cat("\n",nbSp," Espèces conservées pour l'analyse\n\n",sep="")
+    rownames(tabsp) <- tabsp$espece
+    print(tabsp[,1:2])
+    #tabCons <- data.frame(Code_espece = listSp, nom_espece = tabsp[as.character(listSp),"nom"])
+    #print(tabCons)  
+    cat("\n\n",sep="")
+    flush.console()
+
+
+    ## initialisation de la liste de sauvegarde
+
+
+##browser()
+    
+    for (sp in listSp) {  ######## Boucle pour analyse par espèce / loop for the analysis by species
+
+
+        i <- i + 1
+          
+        d <- subset(donneesAll,espece==sp)  ## d data pour l'espece en court  / cut the data keeping only the i species
+        
+        #nomSp <- as.character(tabsp[sp,"nom"])  ## info sp
+        nomSp <- tabsp$nom[which(tabsp$espece==sp)]  ## info sp
+        cat("\n(",i,"/",nbSp,") ",sp," | ", nomSp,"\n",sep="")
+        flush.console()
+
+        #indic <- tabsp[sp,"indicateur"] ## indic :espece utilisee pour le calcul des indicateurs par groupe de specialisation / list the species used as species indicators by trophic specialization
+        indic <- tabsp$indicateur[which(tabsp$espece==sp)] ## indic :espece utilisee pour le calcul des indicateurs par groupe de specialisation / list the species used as species indicators by trophic specialization
+        nb_carre = tapply(rep(1,nrow(d)),d$annee,sum) ## nb_carre nombre de carre suivie par annee / number of plots per year
+        
+        nb_carre_presence = tapply(ifelse(d$abond>0,1,0),d$annee,sum) ## nb_carre_presence nombre de carre de presence par annee / number the plots where the species were observed
+        
+        tab2 <- data.frame(annee=rep(annee,2),val=c(nb_carre,nb_carre_presence),LL = NA,UL=NA, ## tab2 table de resultat d'analyse / data.frame of the analyses results
+                           catPoint=NA,pval=NA,
+                           courbe=rep(c("carre","presence"),each=length(annee)),panel=vpan[2])
+        tab2$catPoint <- ifelse(tab2$val == 0,"0",ifelse(tab2$val < seuilOccu,"infSeuil",NA))
+        
+        abond <- tapply(d$abond,d$annee,sum) ## abond abondance par annee / abundance per year
+        
+        tab3 <- data.frame(annee=annee,val=abond,LL = NA,UL=NA,catPoint=NA,pval=NA,courbe=vpan[3],panel=vpan[3]) ## table pour la figure / data.frame made to realize the graphical outputs
+        tab3$catPoint <- ifelse(tab3$val == 0,"0",ifelse(tab3$val < seuilAbond,"infSeuil",NA))
+
+        ## GLM pour calcul des tendances annuelles de l'evolution des populations / GLM to measure annual tendency of population evolution 
+       formule <- as.formula("abond~as.factor(carre)+as.factor(annee)") #### specification du modèle = log lineaire / specifying the model = log linear
+       if(assessIC) {##### OPTION A RENTRER AU DEBUT PEUT ËTRE A METTRE DANS LES ARGUMENTS SI LAISSE LE CHOIX SINON L ARG PAR DEFAUT LORS DE LA DECLARATION DE LA FONCTION
+           glm1 <- glm(formule,data=d,family=quasipoisson)  ##### fit model lineaire general avec intervalle de confiance disponible / fit linear and generalized model with confidence intervalle available
+       } else {
+           glm1 <- try(speedglm(formule,data=d,family=quasipoisson())) ##### fit modele lineaire et generaux pour les gros jeux de données / fit of linear and generalized model for large-medium dataset
+           if(class(glm1)[1]=="try-error")
+               glm1 <- glm(formule,data=d,family=quasipoisson) ##### comprends pas mais je pense que c'est speedglm qui marche pas avec toutes les données
+       }
+       sglm1 <- summary(glm1)  #### sortie du modele / output of the model
+       sglm1 <- coefficients(sglm1) ### coefficient regression de chaque variable avec les résultats des tests statistiques / regression coefficient of each predictive variables with results of the statistical tests
+       sglm1 <- tail(sglm1,pasdetemps) #### recupére les derniers elements du modèle avec la taille de l'objet "pasdetemps" car le nombre de coef = nbre d'année et pas les coefficient de regression de la variable carre / retrieve only the coefficient regression of the variable year
+       coefan <- as.numeric(as.character(sglm1[,1]))#### coefficient de regression de la variable année (1 pour chaque année)
+        
+        coefannee <- c(1,exp(coefan))## coefannee vecteur des variation d'abondance par annee avec transformation inverse du log :exp() / regression coefficient of the year back transformed from log(abundance) : exp()
+        
+		erreuran <- as.numeric(as.character(sglm1[,2])) #### erreur standard sur le coefficient de regression de la variable annee  / standard error on the regression coefficient of the year 
+        erreurannee1 <- c(0,erreuran*exp(coefan))## erreur standard par année / the standard error per year  ###### LA J AI UN DOUTE NORMALEMENT INTERVAL DE CONF C CI_lower <- coefficients(lin_mod)[2] - 1.96*summary(lin_mod)$coefficients[2,2]
+                                                                                                               ####CI_upper <- coefficients(lin_mod)[2] + 1.96*summary(lin_mod)$coefficients[2,2]
+		
+        pval <- c(1,as.numeric(as.character(sglm1[,4])))###### p value
+        
+        ## calcul des intervalle de confiance avec methode de bootstrap pour simuler des coef de regress sur lequel intervalle de conf sont mesurés/ calcul of the confidence interval using bootstrap method to simulate set regression coefficients and s.e.with uncertainty   POURQUOI PAS UTILISE confint.glm() ou boot() ou ci.boot()
+        
+        if(assessIC) {
+        glm1.sim <- sim(glm1)
+        ic_inf_sim <- c(1,exp(tail(apply(coef(glm1.sim), 2, quantile,.025),pasdetemps)))
+        ic_sup_sim <- c(1,exp(tail(apply(coef(glm1.sim), 2, quantile,.975),pasdetemps)))
+        } else {
+            ic_inf_sim <- NA
+            ic_sup_sim <- NA
+ 
+        }
+        
+        
+        
+        tab1 <- data.frame(annee,val=coefannee,  ## tab1 table pour la realisation des figures / table for the graphical outputs  ### 2EME POUR GRAPH ici ce sont le coef de regress annee en fonction des annéés alors que tab3 c'est les abondance en fct des années et tab2 nombre de carré total et avec presence
+                           LL=ic_inf_sim,UL=ic_sup_sim,
+                           catPoint=ifelse(pval<seuilSignif,"significatif",NA),pval,
+                           courbe=vpan[1],
+                           panel=vpan[1])
+        ## netoyage des intervalle de confiance mal estimés et qd donnees pas suffisantes pour calcul d'IC /cleaning of wrong or biaised measures of the confidence interval
+        if(assessIC) {
+        tab1$UL <- ifelse( nb_carre_presence==0,NA,tab1$UL)
+        tab1$UL <-  ifelse(tab1$UL == Inf, NA,tab1$UL)
+        tab1$UL <-  ifelse(tab1$UL > 1.000000e+20, NA,tab1$UL)
+        tab1$UL[1] <- 1
+        tab1$val <-  ifelse(tab1$val > 1.000000e+20,1.000000e+20,tab1$val)
+        }
+        ## indice de surdispersion  / overdispersion index
+       ## browser()
+        if(assessIC) dispAn <- glm1$deviance/glm1$null.deviance else dispAn <- glm1$deviance/glm1$nulldev
+
+
+        ## tabAn table de sauvegarde des resultats par année / table of the results per year ######  reprends bcp de tabl DIFFERENCE AVEC tab2  c les abondances relatives, alors que nb de carre, nb de carre presnce, p val sont aussi ds tab2
+        tabAn <- data.frame(id,code_espece=sp, nom_espece = nomSp,indicateur = indic,annee = tab1$annee,
+                            abondance_relative=round(tab1$val,3),
+                            IC_inferieur = round(tab1$LL,3), IC_superieur = round(tab1$UL,3),
+                            erreur_standard = round(erreurannee1,4),
+                            p_value = round(tab1$pval,3),significatif = !is.na(tab1$catPoint),
+                            nb_carre,nb_carre_presence,abondance=abond)
+        
+        ## GLM pour calcul des tendance generale sur la periode avec modele log lineaire / GLM to measure the tendency of population evolution on the studied period with log linear model
+        formule <- as.formula(paste("abond~ as.factor(carre) + annee",sep="")) ### 
+          #  browser()
+    
+       
+         if(assessIC) {
+             md2 <- glm(formule,data=d,family=quasipoisson) }
+        else {
+                md2 <- try(speedglm(formule,data=d,family=quasipoisson()),silent=TRUE)
+
+                if(class(md2)[1]=="try-error")
+                    md2 <- glm(formule,data=d,family=quasipoisson)
+            }
+
+        
+       smd2 <- summary(md2)       #### sortie du modele / output of the model
+       smd2 <- coefficients(smd2) ### coefficient regression de chaque variable avec les résultats des tests statistiques / regression coefficient of each predictive variables with results of the statistical tests
+       smd2 <- tail(smd2,1)       ### coefficient regression de variable annee avec les résultats des tests statistiques / regression coefficient of the variable year with results of the statistical tests
+       
+        
+        coefan <- as.numeric(as.character(smd2[,1])) ## tendences sur la periode = coefficient regression de variable annee  / tendency of population evolution on the studied period = regression coefficient of the variable year 
+        trend <- round(exp(coefan),3)
+        
+        pourcentage <- round((exp(coefan*pasdetemps)-1)*100,2) ## pourcentage de variation sur la periode / percentage of population variation on the studied period 
+        pval <- as.numeric(as.character(smd2[,4]))
+        
+        erreuran <- as.numeric(as.character(smd2[,2])) #### récuperer l'erreur standard / retrieve the error 
+        ## erreur standard 
+        erreurannee2 <- erreuran*exp(coefan)
+        
+        
+        ## calcul des intervalle de confiance avec methode de bootstrap pour simuler des coef de regress sur lequel intervalle de conf sont mesurés/ calculating the confidence interval based on bootstrap method to simulate set regression coefficients and s.e.with uncertainty 
+        LL <- NA
+        UL <- NA
+        if(assessIC) {
+            md2.sim <- sim(md2)
+            LL <- round(exp(tail(apply(coef(md2.sim), 2, quantile,.025),1)),3)
+            UL <- round(exp(tail(apply(coef(md2.sim), 2, quantile,.975),1)),3)
+        } else {
+            LL <- NA
+            UL <- NA
+        }
+        
+        ## tab1t table utile pour la realisation des figures  / table used for the figures
+        tab1t <- data.frame(Est=trend,
+                            LL , UL,
+                            pourcent=pourcentage,signif=pval<seuilSignif,pval)
+        
+        
+        trendsignif <- tab1t$signif
+        pourcent <- round((exp(coefan*pasdetemps)-1)*100,3)
+        ## mesure de la surdispersion / overdispersion measurment
+
+          if(assessIC) dispTrend <- md2$deviance/md2$null.deviance else dispTrend <- md2$deviance/md2$nulldev
+
+
+        
+        ## classement en categorie incertain /classifying wrong or not reliable results 
+       # browser()
+        if(assessIC) {
+        if(dispTrend > 2 | dispAn > 2 | median( nb_carre_presence)<seuilOccu) catIncert <- "Incertain" else catIncert <-"bon"  ##### en fonction de l'indice de surdispersion et presence < à seuil occurence / based on the overdispersion index and the presence on a minimum number of plots
+        vecLib <-  NULL
+        if(dispTrend > 2 | dispAn > 2 | median( nb_carre_presence)<seuilOccu) {
+            if(median( nb_carre_presence)<seuilOccu) {
+                vecLib <- c(vecLib,"espece trop rare")
+            }
+            if(dispTrend > 2 | dispAn > 2) {
+                vecLib <- c(vecLib,"deviance")
+            }
+        }
+        raisonIncert <-  paste(vecLib,collapse=" et ")
+        } else {
+            catIncert <- NA
+            raisonIncert <- NA
+        }
+        
+        
+        
+        ## affectation des tendence EBCC  / retrieve the trend of population evolution on the studied period
+        catEBCC <- NA
+        if(assessIC)  catEBCC <- affectCatEBCC(trend = as.vector(trend),pVal = pval,ICinf=as.vector(LL),ICsup=as.vector(UL)) else catEBCC <- NA
+        ## table complete de resultats  pour la periode etudiée / complete table with results for the studied period
+     #   browser()
+        tabTrend <- data.frame(
+            id,code_espece=sp,nom_espece = nomSp,indicateur = indic,
+            nombre_annees = pasdetemps,premiere_annee = firstY,derniere_annee = lastY,
+            tendance = as.vector(trend) ,  IC_inferieur=as.vector(LL) , IC_superieur = as.vector(UL),pourcentage_variation=as.vector(pourcent),
+            erreur_standard = as.vector(round(erreurannee2,4)), p_value = round(pval,3),
+            significatif = trendsignif,categorie_tendance_EBCC=catEBCC,mediane_occurrence=median( nb_carre_presence) ,
+            valide = catIncert,raison_incertitude = raisonIncert)
+
+
+        if(assessIC)  listGLMsp <- list(list(glm1,glm1.sim,md2,md2.sim)) else  listGLMsp <- list(list(glm1,md2))
+        names(listGLMsp)[[1]] <-sp 
+        fileSaveGLMsp <- paste(fileSaveGLMs,"_",sp,".Rdata",sep="")
+        
+        save(listGLMsp,file=fileSaveGLMsp)
+        cat("--->",fileSaveGLMsp,"\n")
+        flush.console()
+
+        if(sp==listSp[1]) {
+            glmAn <- tabAn
+            glmTrend <- tabTrend
+        } else  {
+            glmAn <- rbind(glmAn,tabAn)
+            glmTrend <- rbind(glmTrend,tabTrend)
+        }
+	## les figures     
+        if(figure) {
+            ## table complete pour la figure en panel par ggplot2
+            ## table pour graphe en panel par ggplot2
+            if(description)	dgg <- rbind(tab1,tab2,tab3) else dgg <- tab1
+            ## les figures     
+            
+            ggplot.espece(dgg,tab1t,id,serie=NULL,sp,valide=catIncert,nomSp,description,tendanceSurFigure,seuilOccu=14,vpan = vpan,assessIC=assessIC)
+            
+        }
+        
+        
+        
+        
+    }
+    
+    write.table(glmAn,filesaveAn,row.names=FALSE,quote=FALSE,sep="\t",dec=".",fileEncoding="UTF-8")
+    cat("--->",filesaveAn,"\n")
+    write.table(glmTrend,filesaveTrend,row.names=FALSE,quote=FALSE,sep="\t",dec=".",fileEncoding="UTF-8")
+    cat("--->",filesaveTrend,"\n")
+    
+    
+    flush.console()
+    
+    
+    
+}
+########################################################################################################## Fin de la fonction main.glm / end of the function main.glm
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+
+###########################################################################################################  fonction appelée par main.glm renvoyant la categorie European Bird Census Council en fonction des resultats des modèles  / function called by main.glm to classify results depending on the quality of the data and analyses
+## renvoie la categorie EBCC de la tendance en fonction
+## trend l'estimateur de la tendance / estimation of the trends
+## pVal la p value
+## ICinf ICsup l intervalle de confiance a 95 pourcent
+affectCatEBCC <- function(trend,pVal,ICinf,ICsup){
+  catEBCC <- ifelse(pVal>0.05,
+                    ifelse(ICinf < 0.95 | ICsup > 1.05,"Incertain","Stable"),
+                    ifelse(trend<1,
+                           ifelse(ICsup<0.95,"Fort declin","Declin moderee"),
+                           ifelse(ICinf>1.05,"Forte augmentation","Augmentation modere")))
+  return(catEBCC)
+}
+
+############################################################################################################ fin de la fonction renvoyant la categorie EBCC / end of the function main.glm
+
+
+
+
+
+
+
+
+############################################################################################################ fonction graphique appelée par main.glm / function called by main.glm for graphical output
+ggplot.espece <- function(dgg,tab1t,id,serie=NULL,sp,valide,nomSp=NULL,description=TRUE,
+                          tendanceSurFigure=TRUE,seuilOccu=14, vpan,assessIC=TRUE) {
+  
+  #  serie=NULL;nomSp=NULL;description=TRUE;valide=catIncert
+  #  tendanceSurFigure=TRUE;seuilOccu=14
+  require(ggplot2)
+  
+  figname<- paste("Output/",id,"/",ifelse(valide=="Incertain","Incertain/",""),
+                  sp,"_",id,serie, ".png",
+                  sep = "")
+  ## coordonnee des ligne horizontal de seuil pour les abondances et les occurences
+  hline.data1 <- data.frame(z = c(1), panel = c(vpan[1]),couleur = "variation abondance",type="variation abondance")
+  hline.data2 <- data.frame(z = c(0,seuilOccu), panel = c(vpan[2],vpan[2]),couleur = "seuil",type="seuil")
+  hline.data3 <- data.frame(z = 0, panel = vpan[3] ,couleur = "seuil",type="seuil")  
+  hline.data <- rbind(hline.data1,hline.data2,hline.data3)
+  titre <- paste(nomSp)#,"\n",min(annee)," - ",max(annee),sep="")
+  
+  ## texte de la tendance / text for the population evolution trend
+  tab1 <- subset(dgg,panel =="Variation abondance")
+  pasdetemps <- max(dgg$annee) - min(dgg$annee) + 1
+  if(assessIC){
+      txtPente1 <- paste(tab1t$Est,
+                     ifelse(tab1t$signif," *",""),"  [",tab1t$LL," , ",tab1t$UL,"]",
+                     ifelse(tab1t$signif,paste("\n",ifelse(tab1t$pourcent>0,"+ ","- "),
+                                               abs(tab1t$pourcent)," % en ",pasdetemps," ans",sep=""),""),sep="")
+  }else{
+       txtPente1 <- ifelse(tab1t$signif,paste("\n",ifelse(tab1t$pourcent>0,"+ ","- "),
+                                               abs(tab1t$pourcent)," % en ",pasdetemps," ans",sep=""),"")
+ 
+  }
+  ## table du texte de la tendance / table of the text for the population evolution trend
+  tabTextPent <- data.frame(y=c(max(c(tab1$val,tab1$UL),na.rm=TRUE)*.9),
+                            x=median(tab1$annee),
+                            txt=ifelse(tendanceSurFigure,c(txtPente1),""),
+                            courbe=c(vpan[1]),panel=c(vpan[1]))
+  ## les couleurs / the colors
+  vecColPoint <- c("#ffffff","#eeb40f","#ee0f59")
+  names(vecColPoint) <- c("significatif","infSeuil","0")
+  vecColCourbe <- c("#3c47e0","#5b754d","#55bb1d","#973ce0")
+  names(vecColCourbe) <- c(vpan[1],"carre","presence",vpan[3])
+  vecColHline <- c("#ffffff","#e76060")
+  names(vecColHline) <- c("variation abondance","seuil")
+  
+  col <- c(vecColPoint,vecColCourbe,vecColHline)
+  names(col) <- c(names(vecColPoint),names(vecColCourbe),names(vecColHline))
+  
+  ## si description graphique en 3 panels
+  if(description) {
+    p <- ggplot(data = dgg, mapping = aes(x = annee, y = val))
+    ## Titre, axes ...
+    p <- p + facet_grid(panel ~ ., scale = "free") +
+      theme(legend.position="none",
+            panel.grid.minor=element_blank(),
+            panel.grid.major.y=element_blank())  +
+      ylab("") + xlab("Annee")+ ggtitle(titre) +
+      scale_colour_manual(values=col, name = "" ,
+                          breaks = names(col))+
+      scale_x_continuous(breaks=min(dgg$annee):max(dgg$annee))
+    p <- p + geom_hline(data =hline.data,mapping = aes(yintercept=z, colour = couleur,linetype=type ),
+                        alpha=1,size=1.2)
+   if(assessIC){ ############# ONLY FOR THE CONFIDENCE INTERVAL
+    p <- p + geom_ribbon(mapping=aes(ymin=LL,ymax=UL),fill=col[vpan[1]],alpha=.2) 
+    p <- p + geom_pointrange(mapping= aes(y=val,ymin=LL,ymax=UL),fill=col[vpan[1]],alpha=.2)
+	}
+    p <- p + geom_line(mapping=aes(colour=courbe),size = 1.5)
+    p <- p + geom_point(mapping=aes(colour=courbe),size = 3)
+    p <- p + geom_point(mapping=aes(colour=catPoint,alpha=ifelse(!is.na(catPoint),1,0)),size = 2)
+    p <-  p + geom_text(data=tabTextPent, mapping=aes(x,y,label=txt),parse=FALSE,color=col[vpan[1]],fontface=2, size=4)
+    ggsave(figname, p,width=16,height=21, units="cm")
+	print (figname)  ##### CAN BE REMOVED IF YOU DO NOT WANT THE GRAPH TO BE PLOTTED
+  } else {
+    
+    p <- ggplot(data = subset(dgg,panel=="Variation abondance"), mapping = aes(x = annee, y = val))
+    ## Titre, axes ...
+    p <- p + facet_grid(panel ~ ., scale = "free") +
+      theme(legend.position="none",
+            panel.grid.minor=element_blank(),
+            panel.grid.major.y=element_blank())  +
+      ylab("") + xlab("Annee")+ ggtitle(titre) +
+      scale_colour_manual(values=col, name = "" ,
+                          breaks = names(col))+
+      scale_x_continuous(breaks=min(dgg$annee):max(dgg$annee))
+    p <- p + geom_hline(data =subset(hline.data,panel=="Variation abondance"),mapping = aes(yintercept=z, colour = couleur,linetype=type ),
+                        alpha=1,size=1.2)
+    
+   if(assessIC){ ############# ONLY FOR THE CONFIDENCE INTERVAL
+    p <- p + geom_ribbon(mapping=aes(ymin=LL,ymax=UL),fill=col[vpan[1]],alpha=.2) 
+    p <- p + geom_pointrange(mapping= aes(y=val,ymin=LL,ymax=UL),fill=col[vpan[1]],alpha=.2)
+	}
+    p <- p + geom_line(mapping=aes(colour=courbe),size = 1.5)
+    p <- p + geom_point(mapping=aes(colour=courbe),size = 3)
+    p <- p + geom_point(mapping=aes(colour=catPoint,alpha=ifelse(!is.na(catPoint),1,0)),size = 2)
+    p <-  p + geom_text(data=tabTextPent, mapping=aes(x,y,label=txt),parse=FALSE,color=col[vpan[1]],fontface=2, size=4)
+    ggsave(figname, p,width=15,height=9,units="cm")
+  print (figname) ##### CAN BE REMOVED IF YOU DO NOT WANT THE GRAPH TO BE PLOTTED
+  }
+}
+############################################################################################################ fin fonction graphique / end of function for graphical output
+
+
+
+
+#################################################################################################################### debut de la fonction de moyenne geometrique pondere / start of the geometric weighted mean function 
+geometriqueWeighted <- function(x,w=1) exp(sum(w*log(x))/sum(w))
+#################################################################################################################### fin de la fonction de moyenne geometrique pondere / end of the geometric weighted mean function 
+
+
+
+##################################################################################################################### debut de la fonction analyseGroupe / start of the function analyseGroupe
+## Analyse par groupe de specialisation a partir des resulats de variation d'abondance par especes / analysis by specialization group based on results of the analysis of population evolution trend
+#
+
+
+analyseGroupe <- function(id="france",tabsp=tabsp,donnees=donnees,donneesTrend=donneesTrend,ICfigureGroupeSp=TRUE,powerWeight=2,
+                          correctionAbondanceNull = 0.000001,
+                          groupeNom = c("generaliste","milieux batis","milieux forestiers","milieux agricoles"),
+                          groupeCouleur = c("black","firebrick3","chartreuse4","orange")) {
+    
+    
+
+
+
+    ## donnees tendances globales / results of the global trends
+    donneesTrend <- subset(donneesTrend, select = c(code_espece,valide,mediane_occurrence))
+	
+    ## table de reference espece  / reference table for species
+    tabsp <- subset(tabsp, select= c(sp,nom,indicateur, specialisation))
+    donnees <- merge(donnees,donneesTrend,by="code_espece")
+    donnees <- merge(donnees,tabsp,by.x="code_espece",by.y="sp")
+    ## table de correspondance de biais en fonction des medianes des occuerences
+	
+    
+    nameFileSpe <-  paste("Output/",id,"/variationsAnnuellesGroupes_",id, ############# Declare le fichier de sortie des variations annuelles par groupe / declare the name of the outputfile for annual population evolution trend by group 
+                          ".tabular",sep="" )
+    nameFileSpepng <-  paste("Output/",id,"/variationsAnnuellesGroupes_",id, ############# Declare le fichier de sortie graphique des variations annuelles par groupe / declare the name of the graphical output file for annual population evolution trend by group
+                             ".png",sep="" )
+    
+    grpe <- donnees$specialisation
+    
+    ####### valeur seuil sont obtenues à partir de simulations / threshold values are obtained from simulations
+    ff <- function(x,y) max(which(y<=x)) ## fonction pour recherche le poid associé à valeur max parmi valeur seuil d'occurence inferieur ou egale à occurence mediane obs / function to retrieve the weight associated with the max occurence threshold equal or smaller than the occurence mediane observed
+     
+    IncertW <- ifelse(donnees$valide=="Incertain",tBiais$biais[sapply(as.vector(donnees$mediane_occurrence),ff,y=tBiais$occurrenceMed)],1) ## pr verifier poids de l'espèce dans analyse, récupére seuil occurence minimum pour lequel tendance pas bonne, et compare avec mediane occurence des données  / to check the weight of species in the analysis, this retrieve occurence threshold with wich real occurence measured on data are compared in order to verify the accuracy of the trend measurment
+    ## poids du a la qualite de l'estimation
+                                        #   erreur_stW <- 1/((donnees$erreur_st+1)^powerWeight)
+                                        #	erreur_stW <- ifelse( is.na(donnees$IC_superieur),0,erreur_stW)
+    erreur_stW <- ifelse(is.na(donnees$IC_superieur),0,1)#####  si pas d'interval de confiance met 0 et donne un poid de 0 à l'esps (voir ci dessous) /  if no confidence interval calculated give a weight of 0 for the sps 
+    ## calcul du poids total de chaque espèce / calcul of the weight of each species 
+    W <- IncertW * erreur_stW
+    
+    ## variable de regroupement pour les calculs par groupe de specialisation et par an / variables gathered to identify group for the calculation (per specialization and per year)
+    grAn <- paste(donnees$specialisation,donnees$annee,sep="_")
+    ## data frame pour le calcul / dataframe made for the calcul
+    dd <- data.frame(grAn,annee = donnees$annee, grpe,W,ab=donnees$abondance_relative,ICinf= donnees$IC_inferieur, ICsup= ifelse(is.na(donnees$IC_superieur),10000,donnees$IC_superieur)) 
+    ## table resumer de tous les poids / table to sum up the weights of each species depending on the incertainty in the calcul of the poulation evolution trends
+    ddd <- data.frame(code_espece = donnees$code_espece,nom_espece = donnees$nom_espece,annee = donnees$annee, 
+                      groupe_indicateur = grpe,
+                      poids_erreur_standard = round(erreur_stW,3), poids_incertitude = round(IncertW,3),poids_final = round(W,3),
+                      abondance_relative=donnees$abondance_relative,
+                      IC_inferieur= donnees$IC_inferieur, 
+                      IC_superieur= ifelse(is.na(donnees$IC_superieur),10000,donnees$IC_superieur),
+                      valide = donnees$valide, mediane_occurrence = donnees$mediane_occurrence) 
+
+    nomFileResum <- paste("Output/",id,"/donneesGroupes_",id, ###### declaration du nom du repertoire et des fichiers de sortie / declaring the name of the output folder and files  
+                          ".tabular",sep="" )
+    write.table(ddd,nomFileResum,row.names=FALSE,sep="\t",dec=".",fileEncoding="UTF-8")
+    cat("-->",nomFileResum,"\n")
+    
+    ## calcul des moyennes ponderees par groupe par an et pour les abondance et les IC	/ calcul of weighted means per specialization group and per year for the abundance and confidence interval
+    for(j in 5:7) dd[,j] <- ifelse(dd[,j]==0,correctionAbondanceNull,dd[,j])	
+    ag <- apply(dd[,5:7], 2,  ######## sur les abondances relatives, les ICinf et ICsup
+                function(x) {
+                    sapply(split(data.frame(dd[,1:4], x), dd$grAn),  ###### fait les moyennes pondérés par groupe grAn / calculate the weighted mean by group grAn
+                           function(y) round(geometriqueWeighted(y[,5], w = y$W),3))
+                })
+    ##	gg <- subset(dd,as.character(dd$grAn)=="milieux forestier_2014")  #############################################################
+
+    ag <- ifelse(is.na(ag),1,ag)
+    ag <- as.data.frame(ag)
+    ag$grAn <-  rownames(ag)
+    dbon <- subset(donnees,valide=="bon")
+    dIncert <- subset(donnees,valide=="Incertain")
+    ## calcul nombre d'espece "bonne" pour le calcul / calculating the number of species with low level of incertainty, "good" species 
+    bon <- tapply(dbon$nom,dbon$specialisation,FUN=function(X)length(unique(X)) )
+    bon <- ifelse(is.na(bon),0,bon)
+    tbon <- data.frame(groupe=names(bon),bon)
+    ## calcul nombre d'especes "incertaines" pour le calcul / calculating the number of species with high level of incertainty, "bad" species
+    Incert <- tapply(dIncert$nom,dIncert$specialisation,FUN=function(X)length(unique(X)) )
+    Incert <- ifelse(is.na(Incert),0,Incert)
+    tIncert <- data.frame(groupe=names(Incert),Incertain=Incert)
+
+    tIncert <- merge(tIncert,tbon,by="groupe")
+    
+    ## table de données avec les moyennes ponderees par groupe / table of the data with the weighted mean by group 
+    da <- merge(unique(dd[,1:3]),ag,by="grAn")[,-1]
+    colnames(da) <- c("annee","groupe","abondance_relative","IC_inferieur","IC_superieur")
+
+    da$annee <- as.numeric(da$annee)
+    da <-  merge(da,tIncert,by="groupe") #### ajoute le nombre d'espece "incertaines" et "bonne" aux resultats  / add the number of "good" and "bad" species to the overall resutls
+    da <- subset(da, groupe != "non")
+    colnames(da)[6:7] <-  c("nombre_especes_incertaines","nombre_espece_bonnes")
+    a <- data.frame(id,da)
+    write.table(da,file=nameFileSpe,row.names=FALSE,quote=FALSE,sep="\t",dec=".",fileEncoding="UTF-8")
+
+    cat("-->",nameFileSpe,"\n")
+    yearsrange <- c(min(da$annee),max(da$annee))
+    
+    ## figure par ggplot2  / plots with ggplot2
+    titre <- paste("Variation de l'indicateur groupe de specialisation",sep="")
+
+    vecCouleur <- setNames(groupeCouleur,groupeNom)
+                                        #browser()
+    p <- ggplot(data = da, mapping = aes(x = annee, y = abondance_relative, colour=groupe,fill=groupe))
+    p <- p + geom_hline(aes(yintercept = 1), colour="white", alpha=1,size=1.2) 
+    if(ICfigureGroupeSp)
+        p <- p + geom_ribbon(mapping=aes(ymin=IC_inferieur,ymax=IC_superieur),linetype=2,alpha=.1,size=0.1) 
+    p <- p + geom_line(size=1.5)
+    p <- p +  ylab("") + xlab("Annee")+ ggtitle(titre) 
+    if(!is.null(groupeNom)) p <- p + scale_colour_manual(values=vecCouleur, name = "" )+
+                                scale_x_continuous(breaks=unique(da$annee))
+    if(!is.null(groupeNom)) p <- p +  scale_fill_manual(values=vecCouleur, name="")
+    p <- p +  theme(panel.grid.minor=element_blank(), panel.grid.major.y=element_blank()) 
+    ggsave(nameFileSpepng, p,width=17,height=10,units="cm")
+
+                                        #   cat(" <==",nameFileSpepng,"\n")
+    
+    ## calul pour chaque groupe une pente de regression d'evolution des abondances sur la periode étudiée / calculating for each group the regression slope for the abundance evolution on the studied period
+    vecSpe <- unique(da$groupe)
+    datasum <- data.frame(groupe=NULL,tendance=NULL,pourcentage_variation=NULL)
+    for(spe in 1:4){
+        # print(spe)
+        subtab <- subset(da,groupe==vecSpe[spe])
+        if(nrow(subtab)>1) {
+            sumlm <- summary(lm(abondance_relative~annee,data=subtab)) ##### recupère les resultats du modèle linéaire / retrieve the results of the linear model
+            subdatasum <- data.frame(groupe=vecSpe[spe],
+                                     tendance=round(sumlm$coefficients[2,1],3),
+                                     pourcentage_variation=round(sumlm$coefficients[2,1]*(nrow(subtab)-1)*100,3)) #### assemble les resultats pour en faire une sortie  /  bring together the results for an output file
+            datasum <- rbind(datasum,subdatasum)
+            
+        }
+        
+    }
+    datasum <- merge(datasum,tIncert,by="groupe") #### 
+    datasum <- data.frame(id,datasum)
+                                        #datasum$cat_tendance_EBCC <- affectCatEBCC(trend,pVal,ICinf,ICsup
+    namefilesum <- paste("Output/",id,"/tendancesGlobalesGroupes_",id,
+                         ".tabular",sep="" )
+    write.table(datasum,file=namefilesum,row.names=FALSE,quote=FALSE,sep="\t",dec=".",fileEncoding="UTF-8")
+    cat("-->",namefilesum,"\n")
+}
+
+################################################################################################################## fin de la fonction analyseGroupe / end of the function analyseGroupe
+
+
+
+
+
+
+
+################################################################################################################### debut de la fonction check_file / start of the function check_file
+# Fonction pour verifier les données d'entrée / General function to check integrity of input file. Will check numbers and contents of variables(colnames). 
+#return an error message and exit if mismatch detected
+#Faut rentrer le nom du jeu de données, le nbre et le nom des variables / Enter dataset name,  expected number and names of variables. + an exit error message to guide user.
+
+check_file<-function(dataset,err_msg,vars,nb_vars){
+    if(ncol(dataset)!=nb_vars){ #Verifiction de la présence du bon nb de colonnes, si c'est pas le cas= message d'erreur / checking for right number of columns in the file if not = error message
+        cat("\nerr nb var\n") 
+        stop(err_msg, call.=FALSE)
+    }
+
+    for(i in vars){
+        if(!(i %in% names(dataset))){
+            stop(err_msg,call.=FALSE)
+        }
+    }
+}
+
+#####################################################################################################################
+
--- /dev/null	Thu Jan 01 00:00:00 1970 +0000
+++ b/coordCarreSTOCfaux.tabular	Thu Apr 02 03:35:29 2020 -0400
@@ -0,0 +1,2789 @@
+"V1"	"V2"	"V3"	"pk_carre"	"latitude_grid_wgs84"	"longitude_grid_wgs84"
+NA	NA	NA	"050563"	49.2	-4.98
+NA	NA	NA	"780391"	83.81	6.98
+NA	NA	NA	"810172"	63.35	-2.93
+NA	NA	NA	"010295"	69.63	5.64
+NA	NA	NA	"010492"	40.56	5.46
+NA	NA	NA	"010511"	51.66	7.12
+NA	NA	NA	"010521"	40	4.24
+NA	NA	NA	"010623"	14.86	3.24
+NA	NA	NA	"010873"	61.72	-3.35
+NA	NA	NA	"010884"	31.39	4.06
+NA	NA	NA	"010914"	84.63	-4.7
+NA	NA	NA	"010916"	34.66	-0.94
+NA	NA	NA	"010935"	74.54	4.44
+NA	NA	NA	"010947"	16.35	-2.12
+NA	NA	NA	"010952"	89.02	-2.77
+NA	NA	NA	"011020"	17.43	-3.07
+NA	NA	NA	"011036"	78.76	7.11
+NA	NA	NA	"011103"	75.49	5.96
+NA	NA	NA	"011158"	28.62	7.56
+NA	NA	NA	"011159"	87.34	-1.23
+NA	NA	NA	"011230"	21.8	3.48
+NA	NA	NA	"011303"	88.2	1.37
+NA	NA	NA	"020163"	43.4	-1.42
+NA	NA	NA	"020204"	7.5	-3.53
+NA	NA	NA	"020207"	37.88	0.95
+NA	NA	NA	"020857"	45.58	-0.96
+NA	NA	NA	"021192"	44.03	0.65
+NA	NA	NA	"021279"	88.64	3.36
+NA	NA	NA	"021384"	77.39	-3.28
+NA	NA	NA	"021506"	10.29	5.61
+NA	NA	NA	"021542"	63.68	4.27
+NA	NA	NA	"021784"	63.72	3.56
+NA	NA	NA	"021791"	10.04	1.24
+NA	NA	NA	"030057"	46.92	6.63
+NA	NA	NA	"030148"	58.16	-3.42
+NA	NA	NA	"030190"	11.23	2.86
+NA	NA	NA	"030363"	63.04	6.17
+NA	NA	NA	"030484"	51.84	6.47
+NA	NA	NA	"030537"	46.27	-4.3
+NA	NA	NA	"030582"	79.19	1.1
+NA	NA	NA	"030640"	72.49	7.27
+NA	NA	NA	"030686"	39.48	-0.8
+NA	NA	NA	"030689"	66.78	4.66
+NA	NA	NA	"030769"	29.96	0.76
+NA	NA	NA	"030950"	25.6	1.06
+NA	NA	NA	"030956"	12.27	1.34
+NA	NA	NA	"031383"	77.59	4.32
+NA	NA	NA	"031429"	36.42	2.3
+NA	NA	NA	"031446"	82.08	1.61
+NA	NA	NA	"031739"	23.59	-0.09
+NA	NA	NA	"040558"	22.85	3.56
+NA	NA	NA	"041445"	74.57	7.42
+NA	NA	NA	"041510"	33.3	-4.44
+NA	NA	NA	"060733"	76	-4.29
+NA	NA	NA	"070033"	19.05	3.79
+NA	NA	NA	"070037"	7.39	-2.23
+NA	NA	NA	"070318"	70.73	-2.13
+NA	NA	NA	"070613"	20.77	3.17
+NA	NA	NA	"070659"	59.15	4.08
+NA	NA	NA	"070672"	84.59	-4.64
+NA	NA	NA	"070686"	73.45	7.35
+NA	NA	NA	"070818"	73.92	2.51
+NA	NA	NA	"071071"	75.16	-3.95
+NA	NA	NA	"071185"	87.07	-2.89
+NA	NA	NA	"071249"	75.31	4.85
+NA	NA	NA	"071259"	5.62	4.56
+NA	NA	NA	"080254"	27.51	5.62
+NA	NA	NA	"080558"	37.54	-4.34
+NA	NA	NA	"080602"	78.95	7.49
+NA	NA	NA	"080705"	17.94	3.42
+NA	NA	NA	"080823"	53.13	8.15
+NA	NA	NA	"080946"	55.25	-1.77
+NA	NA	NA	"080964"	57.83	8.09
+NA	NA	NA	"081188"	40.21	1.45
+NA	NA	NA	"081195"	18.24	-3.83
+NA	NA	NA	"090527"	61.81	1.61
+NA	NA	NA	"090616"	78.07	-2.93
+NA	NA	NA	"090996"	51.22	7.89
+NA	NA	NA	"100095"	21.28	3.16
+NA	NA	NA	"100134"	36.05	4.68
+NA	NA	NA	"100171"	74.16	5.59
+NA	NA	NA	"100232"	28.66	-4.48
+NA	NA	NA	"100239"	87.33	8.1
+NA	NA	NA	"100280"	86.08	8.13
+NA	NA	NA	"100310"	28.77	-4.64
+NA	NA	NA	"100400"	84.91	3.07
+NA	NA	NA	"100525"	46.48	6.62
+NA	NA	NA	"100531"	35.84	-0.69
+NA	NA	NA	"100660"	68.75	5.55
+NA	NA	NA	"100685"	68.78	0.86
+NA	NA	NA	"100691"	74.65	8.11
+NA	NA	NA	"100702"	0.18	-2.25
+NA	NA	NA	"100721"	37.09	8.06
+NA	NA	NA	"100846"	17.03	3.69
+NA	NA	NA	"100874"	26.03	-3.29
+NA	NA	NA	"100928"	89.26	3.18
+NA	NA	NA	"210208"	0.27	4.33
+NA	NA	NA	"110622"	50.23	6.65
+NA	NA	NA	"111203"	31.37	4.09
+NA	NA	NA	"120306"	35.1	4.62
+NA	NA	NA	"120323"	54.82	4.45
+NA	NA	NA	"120471"	36.87	4.7
+NA	NA	NA	"120559"	70.42	4.74
+NA	NA	NA	"120599"	69.25	4.67
+NA	NA	NA	"120605"	10.39	1.6
+NA	NA	NA	"120684"	58.15	5.31
+NA	NA	NA	"120699"	5.91	-3.87
+NA	NA	NA	"120767"	32.35	1.49
+NA	NA	NA	"120812"	55.83	4.58
+NA	NA	NA	"120913"	85.04	-1.2
+NA	NA	NA	"121006"	65.68	-3.32
+NA	NA	NA	"121030"	35.48	4.25
+NA	NA	NA	"121196"	71.22	-3.42
+NA	NA	NA	"121427"	51.77	-4.97
+NA	NA	NA	"121835"	45.39	-4.96
+NA	NA	NA	"121913"	54.17	7.02
+NA	NA	NA	"122127"	86.54	6.9
+NA	NA	NA	"150370"	16.52	0.68
+NA	NA	NA	"150424"	72.69	-1.32
+NA	NA	NA	"150663"	55.02	-1.56
+NA	NA	NA	"150760"	79.27	1.09
+NA	NA	NA	"151055"	10.38	1.87
+NA	NA	NA	"151056"	34.48	-0.16
+NA	NA	NA	"151137"	64.84	-0.15
+NA	NA	NA	"151268"	36.41	5.25
+NA	NA	NA	"151376"	88.92	-0.43
+NA	NA	NA	"160748"	68.38	4.88
+NA	NA	NA	"170025"	15.63	-4.03
+NA	NA	NA	"170074"	60.6	1.09
+NA	NA	NA	"170086"	59.33	5.92
+NA	NA	NA	"170104"	2.02	-0.26
+NA	NA	NA	"170109"	77.97	-4.8
+NA	NA	NA	"170123"	29.31	6.93
+NA	NA	NA	"170126"	64.1	-3.88
+NA	NA	NA	"170131"	25.48	2.69
+NA	NA	NA	"170134"	59.5	1.24
+NA	NA	NA	"170154"	25.74	0.29
+NA	NA	NA	"170157"	47.63	-2.91
+NA	NA	NA	"170182"	31.12	7.77
+NA	NA	NA	"170204"	81.36	-2.52
+NA	NA	NA	"170216"	12.97	2.14
+NA	NA	NA	"170219"	70.01	-0.44
+NA	NA	NA	"170220"	39.85	1.86
+NA	NA	NA	"170223"	67.52	-3.41
+NA	NA	NA	"170292"	81.79	0.7
+NA	NA	NA	"170388"	15.69	6.36
+NA	NA	NA	"170468"	48.37	4.18
+NA	NA	NA	"170471"	80.89	2.97
+NA	NA	NA	"170504"	33.12	4.72
+NA	NA	NA	"170598"	45.7	6.88
+NA	NA	NA	"170605"	78.64	6.48
+NA	NA	NA	"170717"	33.09	0.74
+NA	NA	NA	"170721"	67.77	-2.34
+NA	NA	NA	"170727"	32.28	3.28
+NA	NA	NA	"170772"	60.58	0.78
+NA	NA	NA	"170813"	49.3	-2.94
+NA	NA	NA	"170971"	67.8	-1.84
+NA	NA	NA	"171096"	4.71	-0.51
+NA	NA	NA	"171232"	31.6	1.59
+NA	NA	NA	"171359"	44.58	3.05
+NA	NA	NA	"180261"	64.49	-1.69
+NA	NA	NA	"180978"	67.09	5.06
+NA	NA	NA	"190293"	4.98	-0.08
+NA	NA	NA	"190295"	67.8	-3.35
+NA	NA	NA	"210074"	47.81	0
+NA	NA	NA	"210255"	21.23	7.43
+NA	NA	NA	"210372"	27.15	2.32
+NA	NA	NA	"210475"	5.33	3.61
+NA	NA	NA	"210491"	37.53	1.42
+NA	NA	NA	"210521"	57.08	5.11
+NA	NA	NA	"210545"	71.96	2.4
+NA	NA	NA	"210594"	0.61	5.47
+NA	NA	NA	"210824"	30.67	2.32
+NA	NA	NA	"210895"	84.96	-0.36
+NA	NA	NA	"211037"	4.83	2.99
+NA	NA	NA	"211044"	31.85	7.76
+NA	NA	NA	"211050"	73.55	7.5
+NA	NA	NA	"211057"	85.36	6.92
+NA	NA	NA	"211114"	3.65	0.38
+NA	NA	NA	"211176"	5.1	2.13
+NA	NA	NA	"211224"	75.53	4.17
+NA	NA	NA	"211252"	21.06	4.52
+NA	NA	NA	"211271"	3.88	4.21
+NA	NA	NA	"211274"	43.26	-1.27
+NA	NA	NA	"211306"	61.77	2.5
+NA	NA	NA	"211374"	14.48	8.1
+NA	NA	NA	"211452"	32.92	5.75
+NA	NA	NA	"211491"	63.4	2.14
+NA	NA	NA	"211493"	28.06	6.78
+NA	NA	NA	"211542"	84.51	1.49
+NA	NA	NA	"211555"	37.72	-0.31
+NA	NA	NA	"211559"	59.41	5.35
+NA	NA	NA	"211566"	19.22	4.99
+NA	NA	NA	"211813"	30.26	6.66
+NA	NA	NA	"211993"	78.91	0.92
+NA	NA	NA	"211997"	27.95	1.66
+NA	NA	NA	"211999"	31.73	5.91
+NA	NA	NA	"212091"	26.19	3.1
+NA	NA	NA	"220037"	74.17	-1.35
+NA	NA	NA	"230110"	10.05	2.39
+NA	NA	NA	"230139"	12.63	7.37
+NA	NA	NA	"230281"	37.83	-3.06
+NA	NA	NA	"230354"	40.19	1.75
+NA	NA	NA	"230438"	18.43	-0.54
+NA	NA	NA	"230912"	44.01	-0.71
+NA	NA	NA	"240990"	63.55	0.03
+NA	NA	NA	"241147"	21.96	4.86
+NA	NA	NA	"241844"	5.96	2.99
+NA	NA	NA	"241934"	61.61	8.1
+NA	NA	NA	"241956"	65.65	-3.57
+NA	NA	NA	"242244"	68.08	-4.52
+NA	NA	NA	"250021"	25.7	-0.94
+NA	NA	NA	"250029"	55.68	-3.95
+NA	NA	NA	"250099"	26.49	4.56
+NA	NA	NA	"250343"	10.24	1.95
+NA	NA	NA	"250392"	44.57	-2.39
+NA	NA	NA	"250393"	9.82	1.12
+NA	NA	NA	"250416"	7.51	-0.65
+NA	NA	NA	"250476"	67.95	7.27
+NA	NA	NA	"250749"	75.06	3.46
+NA	NA	NA	"250913"	72.44	7.21
+NA	NA	NA	"250992"	59.24	5.56
+NA	NA	NA	"251047"	20.37	-1.49
+NA	NA	NA	"251093"	18.39	6.95
+NA	NA	NA	"251155"	25.46	4.79
+NA	NA	NA	"251170"	29.1	0.94
+NA	NA	NA	"251222"	41.45	-4.19
+NA	NA	NA	"260022"	19.4	4.33
+NA	NA	NA	"260040"	38.96	-3.02
+NA	NA	NA	"260043"	37.05	1.63
+NA	NA	NA	"260113"	84.7	6.93
+NA	NA	NA	"260117"	26.51	-1.27
+NA	NA	NA	"260145"	72.02	-2.8
+NA	NA	NA	"260172"	58.94	5.89
+NA	NA	NA	"260195"	79.08	-3.7
+NA	NA	NA	"260234"	10.02	-0.87
+NA	NA	NA	"260254"	80.34	-1.55
+NA	NA	NA	"260288"	79.2	0.22
+NA	NA	NA	"260333"	64.38	-2.17
+NA	NA	NA	"260386"	28.51	-1.31
+NA	NA	NA	"260391"	58.38	7.23
+NA	NA	NA	"260398"	70.32	7.23
+NA	NA	NA	"260429"	38.41	-2.16
+NA	NA	NA	"260461"	32.77	-4.27
+NA	NA	NA	"260462"	45.51	-2.6
+NA	NA	NA	"260500"	68.32	-1.95
+NA	NA	NA	"260541"	11.24	-0.49
+NA	NA	NA	"260576"	78.25	-1.71
+NA	NA	NA	"260580"	70.68	-2.24
+NA	NA	NA	"260620"	38.31	2.41
+NA	NA	NA	"260663"	30.39	6.6
+NA	NA	NA	"260768"	39.22	4.1
+NA	NA	NA	"260774"	80.82	7.12
+NA	NA	NA	"260778"	12.39	-4.4
+NA	NA	NA	"260838"	28.4	4.19
+NA	NA	NA	"260871"	0.45	4.52
+NA	NA	NA	"260972"	85.66	3.75
+NA	NA	NA	"261029"	66.3	-4.77
+NA	NA	NA	"261089"	53.09	5.77
+NA	NA	NA	"261233"	58.49	5.97
+NA	NA	NA	"261398"	29.8	4.89
+NA	NA	NA	"261446"	20.13	0.74
+NA	NA	NA	"270174"	67.15	-2.58
+NA	NA	NA	"270721"	42.93	4.36
+NA	NA	NA	"270756"	52.36	5.59
+NA	NA	NA	"270762"	54.66	7.49
+NA	NA	NA	"280397"	49.73	6.32
+NA	NA	NA	"290156"	16.95	7.13
+NA	NA	NA	"290404"	3.54	6.97
+NA	NA	NA	"290502"	55.76	1.23
+NA	NA	NA	"290518"	17.47	4.15
+NA	NA	NA	"290551"	57.47	1.97
+NA	NA	NA	"290830"	83.74	5.21
+NA	NA	NA	"291242"	26.94	-3.52
+NA	NA	NA	"291504"	25.41	2.43
+NA	NA	NA	"300551"	69.03	2.82
+NA	NA	NA	"300707"	72.29	-1.52
+NA	NA	NA	"300883"	5.97	-2.86
+NA	NA	NA	"301105"	75.21	-0.35
+NA	NA	NA	"301308"	25.52	0.48
+NA	NA	NA	"310327"	12.91	5.41
+NA	NA	NA	"310507"	46.06	-2.24
+NA	NA	NA	"310543"	40.26	7.97
+NA	NA	NA	"311411"	84.97	-2.57
+NA	NA	NA	"330495"	77.89	-1.96
+NA	NA	NA	"330638"	60.72	4.32
+NA	NA	NA	"331204"	62.47	0.14
+NA	NA	NA	"331206"	80.67	-2.11
+NA	NA	NA	"331422"	83.88	1.85
+NA	NA	NA	"331435"	37.62	6.05
+NA	NA	NA	"331670"	65.18	-2.59
+NA	NA	NA	"331825"	73.68	-0.44
+NA	NA	NA	"331864"	37.92	-1.09
+NA	NA	NA	"332049"	29.32	6.87
+NA	NA	NA	"332399"	83.96	3
+NA	NA	NA	"340048"	80.87	5.84
+NA	NA	NA	"340137"	66.91	1.1
+NA	NA	NA	"340235"	51.01	-3.4
+NA	NA	NA	"340273"	76.85	1.24
+NA	NA	NA	"340376"	65.13	2.49
+NA	NA	NA	"340382"	31.97	5.8
+NA	NA	NA	"340642"	42.53	8.04
+NA	NA	NA	"340705"	57.92	1.42
+NA	NA	NA	"340936"	20.78	4.79
+NA	NA	NA	"341008"	84.58	0.33
+NA	NA	NA	"341222"	52.14	-3.25
+NA	NA	NA	"350015"	28.94	1.99
+NA	NA	NA	"350081"	75.59	6.05
+NA	NA	NA	"350275"	29.76	-1.22
+NA	NA	NA	"350323"	76.35	0.15
+NA	NA	NA	"350376"	64.92	-4.49
+NA	NA	NA	"350431"	18.74	2.1
+NA	NA	NA	"350453"	88.56	2.97
+NA	NA	NA	"350532"	52.3	0.71
+NA	NA	NA	"350565"	84.02	-4.87
+NA	NA	NA	"350587"	63.79	-4.82
+NA	NA	NA	"350653"	30.98	-3.43
+NA	NA	NA	"350739"	79.03	4.34
+NA	NA	NA	"350744"	19.7	-2.04
+NA	NA	NA	"350915"	64.44	-0.68
+NA	NA	NA	"350995"	82.97	-0.38
+NA	NA	NA	"351033"	42.35	6.56
+NA	NA	NA	"351052"	87.49	-1.2
+NA	NA	NA	"351075"	53.18	1.85
+NA	NA	NA	"351128"	46.06	-0.46
+NA	NA	NA	"351213"	54.75	7.47
+NA	NA	NA	"351295"	60.09	-2.49
+NA	NA	NA	"351534"	23.34	3.11
+NA	NA	NA	"351591"	65.91	-4.1
+NA	NA	NA	"351640"	85.54	-4.24
+NA	NA	NA	"370024"	59.66	7.31
+NA	NA	NA	"370466"	25.22	2.28
+NA	NA	NA	"370495"	85.59	7.96
+NA	NA	NA	"370553"	40.18	2.64
+NA	NA	NA	"370567"	7.25	6.18
+NA	NA	NA	"370635"	5.38	5.9
+NA	NA	NA	"370686"	81.28	6.21
+NA	NA	NA	"370791"	5.49	0.87
+NA	NA	NA	"370877"	15.31	3.19
+NA	NA	NA	"370945"	8.09	8.18
+NA	NA	NA	"371118"	23.01	2.18
+NA	NA	NA	"380101"	80.14	2.37
+NA	NA	NA	"380259"	69.09	3.38
+NA	NA	NA	"380271"	52.29	1.08
+NA	NA	NA	"380281"	81.85	0.39
+NA	NA	NA	"380299"	25.42	6.92
+NA	NA	NA	"380377"	50.48	6.16
+NA	NA	NA	"380492"	66.72	5.2
+NA	NA	NA	"380498"	29	3.51
+NA	NA	NA	"380525"	3.88	-0.61
+NA	NA	NA	"380597"	57.99	7.86
+NA	NA	NA	"380626"	67.24	-3.72
+NA	NA	NA	"380633"	88.03	3.78
+NA	NA	NA	"380670"	60.15	2.76
+NA	NA	NA	"620375"	27.4	-4.28
+NA	NA	NA	"380685"	33.17	2.91
+NA	NA	NA	"380710"	57.61	7.44
+NA	NA	NA	"380745"	52.29	4.58
+NA	NA	NA	"380746"	57.96	-3.78
+NA	NA	NA	"380793"	71.95	7.22
+NA	NA	NA	"380857"	20.75	7.54
+NA	NA	NA	"380904"	36.5	2.98
+NA	NA	NA	"381039"	13.2	4.23
+NA	NA	NA	"381079"	21.43	6.05
+NA	NA	NA	"381083"	73.02	1.33
+NA	NA	NA	"381111"	22.89	-0.22
+NA	NA	NA	"381117"	5.62	6.72
+NA	NA	NA	"381220"	58.62	-3.25
+NA	NA	NA	"381233"	53.79	5.08
+NA	NA	NA	"381308"	47.98	2.16
+NA	NA	NA	"381312"	35	-2.02
+NA	NA	NA	"381359"	56.74	6.05
+NA	NA	NA	"381364"	71.44	4.77
+NA	NA	NA	"381504"	75.45	-0.29
+NA	NA	NA	"381546"	47.99	8.06
+NA	NA	NA	"381559"	5.21	-4.72
+NA	NA	NA	"381624"	55.75	0.7
+NA	NA	NA	"381666"	62.87	-3.08
+NA	NA	NA	"381766"	61.34	-0.4
+NA	NA	NA	"381776"	50.83	1.68
+NA	NA	NA	"381837"	19.39	6.91
+NA	NA	NA	"381879"	77.22	1.6
+NA	NA	NA	"381914"	77.44	-1.27
+NA	NA	NA	"390101"	9.17	1.68
+NA	NA	NA	"390123"	61.64	3.92
+NA	NA	NA	"390125"	84.38	6.37
+NA	NA	NA	"390132"	40.94	3.78
+NA	NA	NA	"390134"	73.3	2.97
+NA	NA	NA	"390136"	61.08	-1.93
+NA	NA	NA	"390152"	86.43	6.38
+NA	NA	NA	"390155"	8.28	7.5
+NA	NA	NA	"390210"	58.67	6.33
+NA	NA	NA	"390291"	83.81	4.25
+NA	NA	NA	"390387"	42.72	2.24
+NA	NA	NA	"390624"	8.22	-1.64
+NA	NA	NA	"391100"	44.45	6.39
+NA	NA	NA	"391181"	54.41	4.18
+NA	NA	NA	"391224"	28.16	4.09
+NA	NA	NA	"400048"	47.87	-4.76
+NA	NA	NA	"400288"	45.89	8.03
+NA	NA	NA	"400584"	44.69	-2.09
+NA	NA	NA	"400976"	65.99	6.14
+NA	NA	NA	"402308"	5.11	2.72
+NA	NA	NA	"410323"	64.34	1.58
+NA	NA	NA	"410389"	7.3	6.21
+NA	NA	NA	"410420"	23.23	-4.33
+NA	NA	NA	"410543"	2.65	5.38
+NA	NA	NA	"410566"	52.92	6.44
+NA	NA	NA	"410841"	45.99	-1.63
+NA	NA	NA	"410871"	37.96	0.74
+NA	NA	NA	"410913"	88.45	-4.44
+NA	NA	NA	"410951"	5.74	5.69
+NA	NA	NA	"411251"	35.18	3.3
+NA	NA	NA	"411337"	4.36	-0.3
+NA	NA	NA	"420104"	44.12	-4.25
+NA	NA	NA	"420116"	13.93	7.61
+NA	NA	NA	"420227"	81.16	-2.97
+NA	NA	NA	"420354"	67.69	6.69
+NA	NA	NA	"420420"	68.97	5.63
+NA	NA	NA	"420459"	65.26	-1.69
+NA	NA	NA	"420489"	69.58	6.28
+NA	NA	NA	"420595"	85.88	4.45
+NA	NA	NA	"420679"	9.7	-4.36
+NA	NA	NA	"420723"	29.88	-4.61
+NA	NA	NA	"420740"	59.19	-2.41
+NA	NA	NA	"420759"	70.76	3.89
+NA	NA	NA	"420768"	22.42	-3.77
+NA	NA	NA	"420780"	88.26	-2.56
+NA	NA	NA	"420848"	55.17	4.3
+NA	NA	NA	"420882"	29.58	3.78
+NA	NA	NA	"420967"	38.36	2.01
+NA	NA	NA	"420973"	32.37	4.8
+NA	NA	NA	"420987"	27.73	3.64
+NA	NA	NA	"421052"	21.71	-3.85
+NA	NA	NA	"421066"	9.55	-4.23
+NA	NA	NA	"421087"	3.67	2.84
+NA	NA	NA	"421095"	81.11	-4.32
+NA	NA	NA	"421106"	46.7	-0.95
+NA	NA	NA	"421127"	13	-0.69
+NA	NA	NA	"421159"	51.34	-2.78
+NA	NA	NA	"430368"	46.95	2.39
+NA	NA	NA	"430396"	71.89	-1.84
+NA	NA	NA	"430721"	64.71	7.59
+NA	NA	NA	"430853"	20.36	2.21
+NA	NA	NA	"430912"	39.59	5.84
+NA	NA	NA	"430919"	4.3	5.86
+NA	NA	NA	"430981"	74.01	0.88
+NA	NA	NA	"440072"	47.85	-0.45
+NA	NA	NA	"440168"	89.49	0.13
+NA	NA	NA	"440211"	84.71	2.45
+NA	NA	NA	"440278"	38.74	-3.82
+NA	NA	NA	"440310"	44.26	-4.51
+NA	NA	NA	"440411"	7.22	4.31
+NA	NA	NA	"440480"	75.14	5.09
+NA	NA	NA	"440637"	42.86	6.79
+NA	NA	NA	"440665"	61.81	7.04
+NA	NA	NA	"440841"	34.78	7.97
+NA	NA	NA	"440877"	83.42	3.51
+NA	NA	NA	"440891"	8.39	-2.46
+NA	NA	NA	"440932"	69.61	4.45
+NA	NA	NA	"440989"	65.91	-0.78
+NA	NA	NA	"440990"	26	5.99
+NA	NA	NA	"441008"	52.38	-4.51
+NA	NA	NA	"441032"	76.67	-1.69
+NA	NA	NA	"441051"	83.19	-4.66
+NA	NA	NA	"441053"	60.34	5.27
+NA	NA	NA	"441077"	68.08	0.18
+NA	NA	NA	"441082"	39.86	6.29
+NA	NA	NA	"441109"	71.79	5.6
+NA	NA	NA	"441132"	57.88	-1.5
+NA	NA	NA	"441178"	20.89	-4.33
+NA	NA	NA	"441217"	0.99	-3.95
+NA	NA	NA	"441242"	52.33	2.56
+NA	NA	NA	"441259"	27.87	-1.54
+NA	NA	NA	"441307"	19.26	6.99
+NA	NA	NA	"441311"	88.27	2.46
+NA	NA	NA	"441340"	37.35	2.97
+NA	NA	NA	"441376"	52.71	-1.47
+NA	NA	NA	"441680"	8.85	4.92
+NA	NA	NA	"520099"	17.36	7.38
+NA	NA	NA	"470110"	59.26	5.58
+NA	NA	NA	"470219"	13.7	6.96
+NA	NA	NA	"470247"	77.58	-0.81
+NA	NA	NA	"470366"	69.14	1.49
+NA	NA	NA	"470379"	42.44	6.67
+NA	NA	NA	"470539"	12.43	0.23
+NA	NA	NA	"471014"	28.37	-2.53
+NA	NA	NA	"471218"	39.87	1.75
+NA	NA	NA	"620658"	48.66	-1.21
+NA	NA	NA	"480084"	3.62	0.08
+NA	NA	NA	"480626"	10.23	-2.92
+NA	NA	NA	"480703"	66.54	-0.37
+NA	NA	NA	"480782"	21.03	-1.07
+NA	NA	NA	"480805"	10.29	3.57
+NA	NA	NA	"480807"	70	4.41
+NA	NA	NA	"481013"	0.12	5.86
+NA	NA	NA	"481129"	14.09	5.57
+NA	NA	NA	"490304"	1.59	-3.3
+NA	NA	NA	"490353"	84.82	-1.53
+NA	NA	NA	"490606"	4.41	-4.98
+NA	NA	NA	"490828"	52.56	5.42
+NA	NA	NA	"490910"	41.57	-0.87
+NA	NA	NA	"490963"	57.82	7.62
+NA	NA	NA	"490964"	47.03	1.87
+NA	NA	NA	"490965"	45.3	6.31
+NA	NA	NA	"490966"	84.67	1.55
+NA	NA	NA	"491019"	80.24	4.85
+NA	NA	NA	"491021"	40.73	6.66
+NA	NA	NA	"491025"	50.73	-2.69
+NA	NA	NA	"491032"	83.09	-0.54
+NA	NA	NA	"491062"	56.12	-4.84
+NA	NA	NA	"491081"	76.1	7.52
+NA	NA	NA	"491325"	14.88	3.94
+NA	NA	NA	"491430"	53.17	0.92
+NA	NA	NA	"491449"	7.9	-1.89
+NA	NA	NA	"491502"	43.36	1.68
+NA	NA	NA	"491565"	28.09	-1.45
+NA	NA	NA	"491586"	35.34	6.53
+NA	NA	NA	"491783"	63.04	4.83
+NA	NA	NA	"491784"	87.76	-4.51
+NA	NA	NA	"501068"	55.98	-1.6
+NA	NA	NA	"501434"	79.94	8.17
+NA	NA	NA	"510127"	54.31	7.08
+NA	NA	NA	"510194"	36.39	2.63
+NA	NA	NA	"510197"	44.6	8.09
+NA	NA	NA	"510198"	24.05	5.55
+NA	NA	NA	"510245"	78.94	3.16
+NA	NA	NA	"510288"	34.07	0.34
+NA	NA	NA	"510331"	36.82	4.87
+NA	NA	NA	"510336"	62.13	-0.43
+NA	NA	NA	"510364"	27.75	-3.46
+NA	NA	NA	"510381"	15.59	3.23
+NA	NA	NA	"510383"	38.38	-3.4
+NA	NA	NA	"510402"	54.99	1.71
+NA	NA	NA	"510424"	35.77	4.91
+NA	NA	NA	"510469"	21.13	0.06
+NA	NA	NA	"510471"	61.34	-4.58
+NA	NA	NA	"510645"	71.45	1.28
+NA	NA	NA	"510746"	29.14	7.23
+NA	NA	NA	"511121"	53.95	1.69
+NA	NA	NA	"511147"	31.87	4.13
+NA	NA	NA	"511242"	62.87	-1.73
+NA	NA	NA	"511243"	24.29	7.78
+NA	NA	NA	"511351"	0.58	3.46
+NA	NA	NA	"511354"	3.24	-4.52
+NA	NA	NA	"511458"	80.24	7.66
+NA	NA	NA	"511522"	69.45	-4.6
+NA	NA	NA	"511532"	57.92	-4.05
+NA	NA	NA	"511579"	23.46	4.28
+NA	NA	NA	"511639"	41.41	-4.82
+NA	NA	NA	"511833"	56.65	6.87
+NA	NA	NA	"511834"	46.74	-3.31
+NA	NA	NA	"511876"	64.51	-3.23
+NA	NA	NA	"520012"	76.48	-2.27
+NA	NA	NA	"520094"	15.66	8.18
+NA	NA	NA	"520131"	34.38	-1.38
+NA	NA	NA	"520253"	86.23	6.76
+NA	NA	NA	"520389"	56.35	5.26
+NA	NA	NA	"520812"	53.87	5.94
+NA	NA	NA	"520836"	80.58	4.15
+NA	NA	NA	"521299"	30.22	-1.07
+NA	NA	NA	"521456"	80.74	-3.89
+NA	NA	NA	"530699"	12.95	-2.72
+NA	NA	NA	"530883"	43.02	1.34
+NA	NA	NA	"530964"	61.35	6.54
+NA	NA	NA	"531100"	74.86	-4.37
+NA	NA	NA	"540416"	16.32	6.8
+NA	NA	NA	"540465"	4.44	-0.36
+NA	NA	NA	"540478"	3.31	-0.89
+NA	NA	NA	"540528"	5.36	2.23
+NA	NA	NA	"540667"	78.91	-3.12
+NA	NA	NA	"540731"	58.36	6.23
+NA	NA	NA	"540780"	65.76	-1.14
+NA	NA	NA	"540815"	63.36	-0.76
+NA	NA	NA	"540915"	68.89	0.6
+NA	NA	NA	"540963"	39.5	1.33
+NA	NA	NA	"541073"	85.1	-2.24
+NA	NA	NA	"541157"	33.5	7.72
+NA	NA	NA	"550107"	40.95	4.4
+NA	NA	NA	"551478"	38.43	1.28
+NA	NA	NA	"551484"	18.5	2.69
+NA	NA	NA	"570378"	39.18	-2.34
+NA	NA	NA	"570942"	45.18	-4.24
+NA	NA	NA	"571316"	52.93	-4.24
+NA	NA	NA	"571380"	68.75	5.6
+NA	NA	NA	"571483"	8.03	2.11
+NA	NA	NA	"571548"	26.57	0.9
+NA	NA	NA	"571551"	88.89	2.58
+NA	NA	NA	"580221"	1.33	-2.23
+NA	NA	NA	"580604"	63.96	7.33
+NA	NA	NA	"580617"	37.95	2.99
+NA	NA	NA	"580652"	46.58	-3.47
+NA	NA	NA	"580840"	10.5	5.08
+NA	NA	NA	"580915"	50.52	0
+NA	NA	NA	"581035"	45.01	-1.93
+NA	NA	NA	"581070"	49.41	-4.2
+NA	NA	NA	"581113"	55.07	-3.07
+NA	NA	NA	"581117"	49.47	3.85
+NA	NA	NA	"581165"	59.19	8.17
+NA	NA	NA	"581183"	48.59	3.1
+NA	NA	NA	"581270"	86.89	1.4
+NA	NA	NA	"590201"	17.22	-0.71
+NA	NA	NA	"590590"	4.03	6.33
+NA	NA	NA	"590611"	35.74	3.05
+NA	NA	NA	"590996"	44.9	-3.86
+NA	NA	NA	"600175"	64.73	5.86
+NA	NA	NA	"600368"	67.54	6.93
+NA	NA	NA	"600464"	82.29	-4.22
+NA	NA	NA	"600474"	31.51	1.27
+NA	NA	NA	"600599"	56.89	-3.5
+NA	NA	NA	"600629"	28.38	6.54
+NA	NA	NA	"600874"	28.02	5
+NA	NA	NA	"601012"	50.2	-4.79
+NA	NA	NA	"601281"	39.35	1.27
+NA	NA	NA	"601354"	89.09	5.92
+NA	NA	NA	"601388"	83.34	-4.81
+NA	NA	NA	"601391"	30.7	-3
+NA	NA	NA	"601437"	50.4	-4.1
+NA	NA	NA	"620141"	66.4	-1.25
+NA	NA	NA	"620326"	71.03	-0.99
+NA	NA	NA	"621202"	5.72	3.44
+NA	NA	NA	"621334"	28.85	4.17
+NA	NA	NA	"630136"	83.43	-2.82
+NA	NA	NA	"630142"	50.54	-1.13
+NA	NA	NA	"630167"	49.57	3.4
+NA	NA	NA	"630241"	77.69	0.96
+NA	NA	NA	"630409"	42.48	7.05
+NA	NA	NA	"630437"	88.35	1.89
+NA	NA	NA	"630461"	87.43	-0.69
+NA	NA	NA	"630657"	62.44	2.52
+NA	NA	NA	"630662"	68.3	1.22
+NA	NA	NA	"630781"	66.38	-4.16
+NA	NA	NA	"630839"	5.66	-1.34
+NA	NA	NA	"630868"	42.05	2.67
+NA	NA	NA	"630956"	49.97	1.1
+NA	NA	NA	"631028"	51.92	2.22
+NA	NA	NA	"631073"	55.98	8.18
+NA	NA	NA	"631088"	47.73	-1.45
+NA	NA	NA	"631099"	48.13	-1.78
+NA	NA	NA	"631155"	8.88	2.2
+NA	NA	NA	"631185"	49.06	0.17
+NA	NA	NA	"631189"	58.96	6.62
+NA	NA	NA	"631246"	17.48	-1.18
+NA	NA	NA	"631281"	6.23	5.04
+NA	NA	NA	"631352"	84.62	-3.05
+NA	NA	NA	"631528"	75.74	5.44
+NA	NA	NA	"631590"	39.97	0.94
+NA	NA	NA	"631671"	54.14	1.84
+NA	NA	NA	"631714"	50.65	7.74
+NA	NA	NA	"631782"	43.7	5.64
+NA	NA	NA	"631789"	21.57	-0.82
+NA	NA	NA	"640444"	30.22	2.54
+NA	NA	NA	"640607"	75.12	5.66
+NA	NA	NA	"640610"	25.96	-3.44
+NA	NA	NA	"640708"	13.76	2.86
+NA	NA	NA	"640804"	53.74	4.98
+NA	NA	NA	"640842"	29.01	2.13
+NA	NA	NA	"641279"	61.34	-1.96
+NA	NA	NA	"650541"	25.29	6.83
+NA	NA	NA	"650613"	87.35	5.6
+NA	NA	NA	"660198"	53.04	2.78
+NA	NA	NA	"660248"	21.35	6.51
+NA	NA	NA	"660280"	14.13	0.65
+NA	NA	NA	"660370"	33.25	-3.34
+NA	NA	NA	"660618"	79.32	-4.86
+NA	NA	NA	"660889"	62.36	3.51
+NA	NA	NA	"660931"	65.21	2.57
+NA	NA	NA	"670031"	51.78	4.07
+NA	NA	NA	"670113"	26.14	7.82
+NA	NA	NA	"670119"	84.02	3.89
+NA	NA	NA	"670145"	34.19	7.74
+NA	NA	NA	"670214"	33.17	2.41
+NA	NA	NA	"670271"	48.64	1.06
+NA	NA	NA	"670485"	88.09	-4.79
+NA	NA	NA	"670558"	46.11	2.58
+NA	NA	NA	"670565"	37.42	7.84
+NA	NA	NA	"670567"	45.68	5.03
+NA	NA	NA	"670617"	6.23	-4.93
+NA	NA	NA	"670782"	62.87	0.67
+NA	NA	NA	"670827"	44.56	4.12
+NA	NA	NA	"670945"	15.97	-4.01
+NA	NA	NA	"670973"	32.13	-2.51
+NA	NA	NA	"670995"	50.97	-0.39
+NA	NA	NA	"671134"	55.92	8.12
+NA	NA	NA	"671137"	0.9	4.39
+NA	NA	NA	"671144"	47.59	2.88
+NA	NA	NA	"671145"	27.3	7.83
+NA	NA	NA	"680061"	15.07	7.17
+NA	NA	NA	"680141"	83.76	7.89
+NA	NA	NA	"680154"	46.35	-0.61
+NA	NA	NA	"680281"	15.08	-2.74
+NA	NA	NA	"680311"	35.58	5.31
+NA	NA	NA	"680371"	12.25	6.12
+NA	NA	NA	"680400"	61.85	2.74
+NA	NA	NA	"680582"	47.25	7.26
+NA	NA	NA	"680610"	24.24	-3.98
+NA	NA	NA	"680725"	53.07	4.73
+NA	NA	NA	"680871"	55.05	7.25
+NA	NA	NA	"690015"	76.5	0.24
+NA	NA	NA	"690046"	73.62	3.21
+NA	NA	NA	"690134"	21.68	3.53
+NA	NA	NA	"690145"	72.87	1.51
+NA	NA	NA	"690176"	33.84	5.17
+NA	NA	NA	"690196"	9.12	4.66
+NA	NA	NA	"690247"	76.36	3.6
+NA	NA	NA	"021756"	65.38	3.52
+NA	NA	NA	"690252"	2.69	7.08
+NA	NA	NA	"690300"	23.46	1.9
+NA	NA	NA	"690325"	78.59	-0.27
+NA	NA	NA	"690335"	62.42	-2.09
+NA	NA	NA	"690398"	37.48	2.95
+NA	NA	NA	"690402"	61.73	-4.02
+NA	NA	NA	"690411"	13.14	8.19
+NA	NA	NA	"690425"	72.71	-0.11
+NA	NA	NA	"690455"	69.55	-1.06
+NA	NA	NA	"690491"	61.71	5.54
+NA	NA	NA	"690498"	42.37	6.31
+NA	NA	NA	"690504"	7.94	3.48
+NA	NA	NA	"690547"	47.32	6.02
+NA	NA	NA	"690572"	39.86	0.36
+NA	NA	NA	"690601"	41.36	8.18
+NA	NA	NA	"690626"	34.35	-1.45
+NA	NA	NA	"690662"	77.04	2.07
+NA	NA	NA	"690663"	34.84	6.51
+NA	NA	NA	"690705"	24.46	1.98
+NA	NA	NA	"690715"	52.99	5.44
+NA	NA	NA	"690742"	21.88	1.19
+NA	NA	NA	"690756"	40.69	-0.79
+NA	NA	NA	"690766"	37.77	-4.12
+NA	NA	NA	"690783"	33.49	-4.33
+NA	NA	NA	"690806"	39.96	6.17
+NA	NA	NA	"690810"	1.99	-3.54
+NA	NA	NA	"700267"	38.73	-1.91
+NA	NA	NA	"700289"	24.48	5.04
+NA	NA	NA	"700371"	4.43	5.21
+NA	NA	NA	"700373"	65.43	7.04
+NA	NA	NA	"700416"	8.36	0.44
+NA	NA	NA	"700446"	46.51	-0.4
+NA	NA	NA	"700594"	35.35	-3.25
+NA	NA	NA	"700602"	14.63	-4.3
+NA	NA	NA	"700654"	55.08	-4.29
+NA	NA	NA	"700775"	74.68	1.83
+NA	NA	NA	"700789"	46.83	2.78
+NA	NA	NA	"700791"	36.31	2.94
+NA	NA	NA	"700891"	48.47	-2.59
+NA	NA	NA	"700898"	57.39	-2.05
+NA	NA	NA	"701036"	24.4	-1.72
+NA	NA	NA	"701059"	19.99	2.98
+NA	NA	NA	"701070"	63.83	-2.01
+NA	NA	NA	"701072"	20.65	-4.31
+NA	NA	NA	"701239"	59.06	0.91
+NA	NA	NA	"701314"	57.88	7.58
+NA	NA	NA	"710037"	66.3	-1.19
+NA	NA	NA	"710131"	66.28	2
+NA	NA	NA	"710257"	56.03	-1.18
+NA	NA	NA	"710311"	65.68	-0.5
+NA	NA	NA	"710345"	78.91	2.37
+NA	NA	NA	"710372"	19.11	-3.04
+NA	NA	NA	"710443"	40.44	5.71
+NA	NA	NA	"710458"	85.7	4.36
+NA	NA	NA	"710548"	50.03	6.27
+NA	NA	NA	"710589"	71.67	-2.36
+NA	NA	NA	"710686"	63.11	-4.84
+NA	NA	NA	"710716"	48.27	3.03
+NA	NA	NA	"710751"	26.32	1.8
+NA	NA	NA	"710794"	29.31	-4.46
+NA	NA	NA	"710819"	51.8	-3.9
+NA	NA	NA	"710823"	0.84	4.61
+NA	NA	NA	"710826"	74.07	0.93
+NA	NA	NA	"710836"	9.45	0.38
+NA	NA	NA	"710893"	2.24	-4.31
+NA	NA	NA	"710948"	42.37	-2.54
+NA	NA	NA	"710949"	27.46	7.48
+NA	NA	NA	"711014"	68.53	5.83
+NA	NA	NA	"711026"	43.29	6.06
+NA	NA	NA	"711079"	68.56	6.9
+NA	NA	NA	"711165"	21.33	2.47
+NA	NA	NA	"711204"	29.29	6.61
+NA	NA	NA	"711233"	40.05	-4.27
+NA	NA	NA	"711344"	10.79	-2
+NA	NA	NA	"711466"	3.26	5.43
+NA	NA	NA	"711474"	4.37	1.08
+NA	NA	NA	"711515"	46.42	4.39
+NA	NA	NA	"711540"	35.59	-0.13
+NA	NA	NA	"711901"	75.92	3.86
+NA	NA	NA	"711908"	51.82	5.26
+NA	NA	NA	"711923"	57.22	-0.31
+NA	NA	NA	"712096"	42.49	0.38
+NA	NA	NA	"720038"	21.73	4.45
+NA	NA	NA	"720242"	24.6	-2.61
+NA	NA	NA	"720686"	87.58	4.04
+NA	NA	NA	"720910"	41.58	-1.22
+NA	NA	NA	"721136"	83.37	-3.91
+NA	NA	NA	"721251"	30.76	5.17
+NA	NA	NA	"730074"	45.36	0.89
+NA	NA	NA	"730141"	20.6	4.55
+NA	NA	NA	"730183"	11.01	7.41
+NA	NA	NA	"730374"	87.78	4.75
+NA	NA	NA	"730413"	10.12	-0.99
+NA	NA	NA	"730479"	88.6	0.56
+NA	NA	NA	"730496"	59.13	5.85
+NA	NA	NA	"730521"	39.52	-2.5
+NA	NA	NA	"730601"	37.36	-3.65
+NA	NA	NA	"730625"	37.13	-0.56
+NA	NA	NA	"730627"	40.67	-3.92
+NA	NA	NA	"730684"	6.66	-4.9
+NA	NA	NA	"730731"	19.29	1.03
+NA	NA	NA	"730733"	28.15	-1.08
+NA	NA	NA	"730777"	25.84	-2.82
+NA	NA	NA	"730792"	65.83	-0.17
+NA	NA	NA	"730803"	63.78	-2.56
+NA	NA	NA	"730836"	47.33	3.72
+NA	NA	NA	"730856"	77.12	1.16
+NA	NA	NA	"740014"	40.7	5.04
+NA	NA	NA	"740031"	49	-3.07
+NA	NA	NA	"740084"	59.92	-2.09
+NA	NA	NA	"740113"	51.54	6.57
+NA	NA	NA	"740135"	89.5	4.65
+NA	NA	NA	"740233"	56.67	-3.46
+NA	NA	NA	"740259"	55.36	2.78
+NA	NA	NA	"740284"	63.86	-3.59
+NA	NA	NA	"740335"	51.92	0.85
+NA	NA	NA	"740337"	47.13	0.23
+NA	NA	NA	"740449"	19.2	3.89
+NA	NA	NA	"740506"	24.82	4.83
+NA	NA	NA	"740581"	59.26	-2.07
+NA	NA	NA	"740628"	53.12	-1.42
+NA	NA	NA	"740633"	9.27	3.25
+NA	NA	NA	"740726"	66.2	-1.88
+NA	NA	NA	"740750"	82.6	6.46
+NA	NA	NA	"740755"	10.85	2.99
+NA	NA	NA	"740827"	77.53	2.67
+NA	NA	NA	"740864"	89.12	3.54
+NA	NA	NA	"740886"	63.94	-1.86
+NA	NA	NA	"740907"	55.34	6.08
+NA	NA	NA	"740938"	17.63	1.38
+NA	NA	NA	"740979"	44.64	-2.54
+NA	NA	NA	"740981"	30.62	5.56
+NA	NA	NA	"741051"	79.97	6.22
+NA	NA	NA	"741122"	64.35	4.86
+NA	NA	NA	"750008"	83.67	-2.39
+NA	NA	NA	"750015"	2.29	4.11
+NA	NA	NA	"750018"	10.61	-1.45
+NA	NA	NA	"750023"	13.62	5.24
+NA	NA	NA	"750025"	22.41	-2.6
+NA	NA	NA	"761436"	78.95	6.56
+NA	NA	NA	"761524"	54.64	8.08
+NA	NA	NA	"761555"	85.88	6.34
+NA	NA	NA	"761559"	16.11	-1.54
+NA	NA	NA	"770238"	62.7	-2.36
+NA	NA	NA	"770384"	69.35	-2.36
+NA	NA	NA	"770487"	22.11	6.74
+NA	NA	NA	"770815"	71.94	2.14
+NA	NA	NA	"771028"	86.47	-1.19
+NA	NA	NA	"771159"	47.1	-1.93
+NA	NA	NA	"771201"	60.76	4.82
+NA	NA	NA	"771229"	44.01	-1.36
+NA	NA	NA	"771230"	3.56	-0.65
+NA	NA	NA	"771255"	83.88	-2.43
+NA	NA	NA	"771283"	54.8	-3.97
+NA	NA	NA	"780123"	86.59	-0.38
+NA	NA	NA	"780131"	8.69	4.39
+NA	NA	NA	"780140"	53.57	0.64
+NA	NA	NA	"780227"	64.91	7.07
+NA	NA	NA	"780248"	5.17	-2.99
+NA	NA	NA	"780334"	27.71	1.97
+NA	NA	NA	"780397"	64.65	-1.39
+NA	NA	NA	"780448"	14.04	4.53
+NA	NA	NA	"780454"	53.68	-2.92
+NA	NA	NA	"780464"	14.15	7.18
+NA	NA	NA	"790014"	36.11	-1.46
+NA	NA	NA	"790409"	23.94	7.55
+NA	NA	NA	"790516"	67.59	1.32
+NA	NA	NA	"790936"	49.51	3.17
+NA	NA	NA	"790959"	39.9	2.18
+NA	NA	NA	"791051"	21.6	6.53
+NA	NA	NA	"791057"	71.82	-1.35
+NA	NA	NA	"796126"	61.83	3.49
+NA	NA	NA	"800015"	53.69	2.65
+NA	NA	NA	"800028"	31.49	5.74
+NA	NA	NA	"800086"	77.41	-4.58
+NA	NA	NA	"800487"	1.23	-4.15
+NA	NA	NA	"800871"	15.77	0.61
+NA	NA	NA	"800872"	33.14	-4.25
+NA	NA	NA	"800910"	18.5	-0.07
+NA	NA	NA	"801025"	79.37	6.21
+NA	NA	NA	"801127"	1.42	-3.74
+NA	NA	NA	"801218"	21.81	-0.53
+NA	NA	NA	"801258"	43.98	0.47
+NA	NA	NA	"801318"	12.38	-0.52
+NA	NA	NA	"801497"	64.95	-2.37
+NA	NA	NA	"810020"	86.8	6.53
+NA	NA	NA	"810153"	34.24	-2.92
+NA	NA	NA	"811276"	37.74	2.86
+NA	NA	NA	"811366"	43.76	1.02
+NA	NA	NA	"830092"	29.96	-1.48
+NA	NA	NA	"830167"	46.45	-0.16
+NA	NA	NA	"830626"	85.69	-3.5
+NA	NA	NA	"830627"	20.45	4.57
+NA	NA	NA	"830646"	63.63	5.44
+NA	NA	NA	"830678"	83.99	1.26
+NA	NA	NA	"831199"	0.49	1.69
+NA	NA	NA	"831237"	8.17	-0.81
+NA	NA	NA	"831302"	34.64	5.14
+NA	NA	NA	"840486"	6.23	6.08
+NA	NA	NA	"840577"	88.83	5.57
+NA	NA	NA	"850209"	78.58	6.27
+NA	NA	NA	"850248"	89.69	-2.28
+NA	NA	NA	"850436"	40.17	-4.57
+NA	NA	NA	"850796"	13.75	-0.6
+NA	NA	NA	"850839"	56.11	3.89
+NA	NA	NA	"850885"	23.32	2.3
+NA	NA	NA	"850927"	44.27	-4.14
+NA	NA	NA	"850961"	13.24	0.87
+NA	NA	NA	"850972"	69.8	-2.35
+NA	NA	NA	"851036"	32.95	-0.37
+NA	NA	NA	"851038"	61.44	-1.48
+NA	NA	NA	"851040"	42.41	-3.5
+NA	NA	NA	"851237"	7.04	0.47
+NA	NA	NA	"851297"	69.47	-4.25
+NA	NA	NA	"851327"	17.19	2.02
+NA	NA	NA	"851368"	17.55	6.85
+NA	NA	NA	"851383"	68.58	2.85
+NA	NA	NA	"851390"	18.7	6.47
+NA	NA	NA	"851433"	15.43	-2.29
+NA	NA	NA	"851491"	72.52	-3.88
+NA	NA	NA	"851569"	4.42	5.42
+NA	NA	NA	"851621"	12.09	2.73
+NA	NA	NA	"851625"	23.34	-1.01
+NA	NA	NA	"851693"	23.93	7.05
+NA	NA	NA	"860131"	35.74	2.01
+NA	NA	NA	"860289"	38.5	1.02
+NA	NA	NA	"860322"	73.89	0.85
+NA	NA	NA	"860351"	63.39	-4.56
+NA	NA	NA	"860411"	42.29	4.71
+NA	NA	NA	"860443"	4.93	3.42
+NA	NA	NA	"020085"	31.74	-3.7
+NA	NA	NA	"860448"	1.53	0.7
+NA	NA	NA	"860476"	38.37	5.02
+NA	NA	NA	"860562"	21.08	-4.97
+NA	NA	NA	"860574"	81.54	-4.09
+NA	NA	NA	"860602"	50.17	2.3
+NA	NA	NA	"860616"	89.74	-4.34
+NA	NA	NA	"860644"	42.02	2.24
+NA	NA	NA	"860649"	31.12	1.8
+NA	NA	NA	"860653"	73.89	1.18
+NA	NA	NA	"860662"	8.91	0.23
+NA	NA	NA	"860672"	69.86	6.33
+NA	NA	NA	"860693"	3.75	-4.25
+NA	NA	NA	"860899"	89.72	-1.08
+NA	NA	NA	"861012"	35.53	0.27
+NA	NA	NA	"861013"	83.94	2.68
+NA	NA	NA	"861021"	50.53	-1.15
+NA	NA	NA	"861078"	39.78	1.63
+NA	NA	NA	"861106"	4.33	1.2
+NA	NA	NA	"861160"	10.74	-4.27
+NA	NA	NA	"861280"	77.61	-0.97
+NA	NA	NA	"861481"	67.04	-3.33
+NA	NA	NA	"861507"	72.34	-0.31
+NA	NA	NA	"870862"	4.87	-1.85
+NA	NA	NA	"870883"	82.99	7.83
+NA	NA	NA	"880014"	51.9	-3.94
+NA	NA	NA	"880042"	84.85	-0.38
+NA	NA	NA	"880059"	24.84	-3.3
+NA	NA	NA	"880065"	18.01	3.15
+NA	NA	NA	"880394"	49.46	4.09
+NA	NA	NA	"881191"	37.56	-2.39
+NA	NA	NA	"881256"	76.82	1.97
+NA	NA	NA	"881352"	71.1	6.13
+NA	NA	NA	"890047"	10.16	2.81
+NA	NA	NA	"890054"	89.5	4.61
+NA	NA	NA	"890174"	57.33	6.51
+NA	NA	NA	"890221"	62.94	0.64
+NA	NA	NA	"890223"	33.54	4.22
+NA	NA	NA	"890248"	86.03	-3.42
+NA	NA	NA	"890276"	52.17	-1.27
+NA	NA	NA	"890365"	6.57	-0.43
+NA	NA	NA	"890401"	26.79	2.32
+NA	NA	NA	"890426"	63.28	-1.53
+NA	NA	NA	"890504"	74.91	-2.14
+NA	NA	NA	"890527"	78.27	2.4
+NA	NA	NA	"890535"	55.01	-3.04
+NA	NA	NA	"890543"	17.91	3.15
+NA	NA	NA	"890555"	78.01	-2.01
+NA	NA	NA	"890561"	2.82	3.81
+NA	NA	NA	"890567"	20.77	-4.16
+NA	NA	NA	"890569"	69.94	2.79
+NA	NA	NA	"890576"	28.41	6.79
+NA	NA	NA	"890593"	77.53	0.36
+NA	NA	NA	"890596"	38.01	-0.1
+NA	NA	NA	"890728"	58.11	1.59
+NA	NA	NA	"890788"	3.21	-2.86
+NA	NA	NA	"890815"	29.22	1.41
+NA	NA	NA	"890819"	36.61	-2.56
+NA	NA	NA	"890840"	68.98	1.23
+NA	NA	NA	"890869"	60.11	0.85
+NA	NA	NA	"890913"	56.49	-0.2
+NA	NA	NA	"890936"	37.73	7.15
+NA	NA	NA	"890938"	69.76	-3.81
+NA	NA	NA	"890951"	24.72	-2.36
+NA	NA	NA	"891013"	48.78	-0.83
+NA	NA	NA	"891036"	20.17	-4.39
+NA	NA	NA	"891045"	30.9	-1.29
+NA	NA	NA	"891125"	2.89	6.68
+NA	NA	NA	"891149"	75.89	1.82
+NA	NA	NA	"891228"	66.58	-4.67
+NA	NA	NA	"891241"	55.97	7.08
+NA	NA	NA	"891267"	55.52	1.47
+NA	NA	NA	"891377"	78.07	-1.8
+NA	NA	NA	"891507"	48.83	1
+NA	NA	NA	"891520"	54.04	7.17
+NA	NA	NA	"891733"	52.21	5.27
+NA	NA	NA	"891818"	17.01	6.64
+NA	NA	NA	"900024"	0.72	3.45
+NA	NA	NA	"900041"	23.69	-2.92
+NA	NA	NA	"900048"	20.46	-0.05
+NA	NA	NA	"900073"	59.15	2.06
+NA	NA	NA	"900083"	8.9	3.31
+NA	NA	NA	"900098"	64.88	3
+NA	NA	NA	"900108"	56.17	0.12
+NA	NA	NA	"900112"	87.62	3.7
+NA	NA	NA	"900120"	75.66	2.87
+NA	NA	NA	"910016"	58.45	-1.97
+NA	NA	NA	"910028"	33.85	4.22
+NA	NA	NA	"910041"	59.01	1.56
+NA	NA	NA	"910047"	15.58	-1.9
+NA	NA	NA	"910083"	9.29	3.22
+NA	NA	NA	"910089"	44.55	6.31
+NA	NA	NA	"910196"	60.11	5.34
+NA	NA	NA	"910220"	48.15	1.14
+NA	NA	NA	"910230"	1.99	0.21
+NA	NA	NA	"910241"	73.88	-2.82
+NA	NA	NA	"920004"	66.94	-4.59
+NA	NA	NA	"920019"	14.01	0.52
+NA	NA	NA	"920028"	57.77	-2.33
+NA	NA	NA	"920040"	22.18	2.36
+NA	NA	NA	"920043"	22.45	-3.05
+NA	NA	NA	"930008"	70.1	-2.43
+NA	NA	NA	"930016"	85.82	4.81
+NA	NA	NA	"930019"	74.31	-0.63
+NA	NA	NA	"930020"	75.65	-2.33
+NA	NA	NA	"930026"	10.24	6.92
+NA	NA	NA	"930037"	88.76	-0.77
+NA	NA	NA	"021799"	89.65	-2.26
+NA	NA	NA	"930039"	48.26	0.42
+NA	NA	NA	"930040"	79.55	1.95
+NA	NA	NA	"930046"	79.04	7.76
+NA	NA	NA	"940014"	30.95	-2.31
+NA	NA	NA	"940020"	81.6	-0.17
+NA	NA	NA	"940022"	74.87	-0.18
+NA	NA	NA	"940026"	47.83	6.13
+NA	NA	NA	"940033"	2.49	-0.96
+NA	NA	NA	"950123"	30.72	3.98
+NA	NA	NA	"950212"	9.18	6.65
+NA	NA	NA	"950213"	3.71	-3.7
+NA	NA	NA	"950234"	30.84	3.14
+NA	NA	NA	"950237"	42.56	2.39
+NA	NA	NA	"950238"	36.71	-0.05
+NA	NA	NA	"950283"	71.91	-3.97
+NA	NA	NA	"950294"	60.03	0.53
+NA	NA	NA	"Ile de"	35.16	3.94
+NA	NA	NA	"Le Mas"	29.43	-3.13
+NA	NA	NA	"010100"	86.02	3.07
+NA	NA	NA	"010120"	54.74	8.03
+NA	NA	NA	"010487"	57.58	-1.07
+NA	NA	NA	"010506"	11.94	7.89
+NA	NA	NA	"010604"	17.3	2.63
+NA	NA	NA	"010607"	88.04	3
+NA	NA	NA	"010696"	77.54	6.7
+NA	NA	NA	"010957"	9.67	2.84
+NA	NA	NA	"010999"	1.59	7.96
+NA	NA	NA	"011134"	74.33	-0.09
+NA	NA	NA	"011240"	5.14	-4.95
+NA	NA	NA	"020006"	17.44	0.71
+NA	NA	NA	"020137"	77.5	-2.46
+NA	NA	NA	"020526"	66.61	-4.26
+NA	NA	NA	"020799"	41.71	-2.9
+NA	NA	NA	"020847"	57.81	-0.42
+NA	NA	NA	"020881"	26.45	6.12
+NA	NA	NA	"021088"	82.33	4.29
+NA	NA	NA	"021172"	15.26	-1.77
+NA	NA	NA	"021195"	68.2	7.26
+NA	NA	NA	"021312"	82.03	-4.14
+NA	NA	NA	"030034"	57.88	1.82
+NA	NA	NA	"030143"	25.33	-4.82
+NA	NA	NA	"030145"	55.09	6.91
+NA	NA	NA	"030208"	3.07	1.72
+NA	NA	NA	"030240"	30.74	7.98
+NA	NA	NA	"030249"	48.47	8.14
+NA	NA	NA	"030292"	54.85	3.63
+NA	NA	NA	"030352"	11.63	2.11
+NA	NA	NA	"030523"	63.84	-3.1
+NA	NA	NA	"030567"	42.65	-4.58
+NA	NA	NA	"030932"	10.96	-1.83
+NA	NA	NA	"031040"	26.85	-1.76
+NA	NA	NA	"031234"	74.65	-2.5
+NA	NA	NA	"031368"	67.74	2.33
+NA	NA	NA	"031397"	25.41	-3.11
+NA	NA	NA	"031522"	19.25	1.68
+NA	NA	NA	"031537"	14.2	1.02
+NA	NA	NA	"031716"	73.28	-0.39
+NA	NA	NA	"031722"	87.61	-4.34
+NA	NA	NA	"031782"	34	-1.42
+NA	NA	NA	"040309"	19.25	1.91
+NA	NA	NA	"040533"	63.61	-4.07
+NA	NA	NA	"040578"	53.52	1.72
+NA	NA	NA	"040637"	45.97	3.71
+NA	NA	NA	"040910"	40.35	-3.25
+NA	NA	NA	"041044"	37.81	2.85
+NA	NA	NA	"041098"	58.41	6.44
+NA	NA	NA	"041149"	52.83	0.23
+NA	NA	NA	"041449"	14.44	2.24
+NA	NA	NA	"041513"	39.47	1.86
+NA	NA	NA	"041555"	9.92	-1.95
+NA	NA	NA	"041670"	20.42	-1.18
+NA	NA	NA	"041736"	36.43	0.53
+NA	NA	NA	"050088"	62.9	6.1
+NA	NA	NA	"050089"	43.85	5.77
+NA	NA	NA	"050141"	32.08	5.87
+NA	NA	NA	"050158"	26.82	-0.73
+NA	NA	NA	"050160"	64.69	3.3
+NA	NA	NA	"050204"	40.18	-3.35
+NA	NA	NA	"050401"	36.26	6.53
+NA	NA	NA	"050655"	84.97	-2.22
+NA	NA	NA	"050700"	25.17	-1.81
+NA	NA	NA	"050793"	76.53	-4.48
+NA	NA	NA	"050925"	19.92	0.18
+NA	NA	NA	"050967"	53	2.18
+NA	NA	NA	"051045"	50.47	-4.43
+NA	NA	NA	"051046"	3.82	4.75
+NA	NA	NA	"051062"	84.16	0.91
+NA	NA	NA	"051366"	9.67	-4.67
+NA	NA	NA	"060015"	62.57	3.1
+NA	NA	NA	"060085"	7.56	-0.67
+NA	NA	NA	"060233"	28.1	5.79
+NA	NA	NA	"060798"	82.4	2.03
+NA	NA	NA	"060805"	29.45	6.86
+NA	NA	NA	"060867"	53.13	6.15
+NA	NA	NA	"060895"	2.54	3.05
+NA	NA	NA	"060915"	61.49	0
+NA	NA	NA	"060964"	60.04	-1.43
+NA	NA	NA	"060966"	89.01	2.73
+NA	NA	NA	"060984"	38.75	6.83
+NA	NA	NA	"070039"	52.62	-2.04
+NA	NA	NA	"070108"	83.24	1.38
+NA	NA	NA	"070147"	41.24	-3.71
+NA	NA	NA	"070214"	3.42	-1.17
+NA	NA	NA	"070281"	2.37	-2.9
+NA	NA	NA	"070305"	35.02	7.54
+NA	NA	NA	"070451"	89.95	3.51
+NA	NA	NA	"070582"	80.12	3.9
+NA	NA	NA	"070679"	20.89	6.54
+NA	NA	NA	"070731"	54.26	0.6
+NA	NA	NA	"070779"	0.41	3.29
+NA	NA	NA	"080047"	89.63	-4.1
+NA	NA	NA	"080072"	88.4	0.86
+NA	NA	NA	"080169"	53.8	0.99
+NA	NA	NA	"080231"	61.76	-0.97
+NA	NA	NA	"080235"	2.15	1.58
+NA	NA	NA	"080236"	43.22	4.5
+NA	NA	NA	"080297"	85.35	-3.35
+NA	NA	NA	"080306"	66.8	-4.06
+NA	NA	NA	"080308"	48.62	-3.77
+NA	NA	NA	"080440"	79.51	2.57
+NA	NA	NA	"080528"	70.63	-2.31
+NA	NA	NA	"080598"	50.49	-2.31
+NA	NA	NA	"080614"	41.15	0.92
+NA	NA	NA	"080710"	87.44	0.26
+NA	NA	NA	"080745"	26.36	0.89
+NA	NA	NA	"080933"	67.03	7.29
+NA	NA	NA	"080936"	73.59	2.56
+NA	NA	NA	"081045"	81.97	4.16
+NA	NA	NA	"081083"	33.62	-3.68
+NA	NA	NA	"081225"	34.27	3.66
+NA	NA	NA	"090247"	34.49	-1.55
+NA	NA	NA	"090317"	34.19	7.78
+NA	NA	NA	"090336"	29.35	4.88
+NA	NA	NA	"090369"	0.28	-0.08
+NA	NA	NA	"090460"	19.26	-3.51
+NA	NA	NA	"090473"	54.79	0.75
+NA	NA	NA	"090478"	14.12	6.26
+NA	NA	NA	"090497"	32.55	-1
+NA	NA	NA	"090503"	73.71	6.08
+NA	NA	NA	"090546"	54.52	-1.76
+NA	NA	NA	"090567"	74.54	1.03
+NA	NA	NA	"090589"	33.88	-3.37
+NA	NA	NA	"090631"	29.65	-1.66
+NA	NA	NA	"091141"	89.61	6.45
+NA	NA	NA	"100154"	57.95	-3.52
+NA	NA	NA	"100271"	24.47	3.18
+NA	NA	NA	"100275"	20.5	-4.3
+NA	NA	NA	"100559"	7.87	5.25
+NA	NA	NA	"100695"	61.5	-1.22
+NA	NA	NA	"100833"	40.46	-1.23
+NA	NA	NA	"100950"	10.06	-0.46
+NA	NA	NA	"100998"	4.07	2.85
+NA	NA	NA	"101047"	63.22	-4.9
+NA	NA	NA	"101101"	53.44	1.62
+NA	NA	NA	"101206"	31.33	0.78
+NA	NA	NA	"110390"	87.38	-2.57
+NA	NA	NA	"110573"	0.15	-4.96
+NA	NA	NA	"110791"	87.83	3.82
+NA	NA	NA	"111007"	82.06	-1.79
+NA	NA	NA	"111108"	64.47	-4.04
+NA	NA	NA	"111306"	63.1	2.8
+NA	NA	NA	"111388"	9.34	7.12
+NA	NA	NA	"120082"	9	4.99
+NA	NA	NA	"120307"	82.03	-2.86
+NA	NA	NA	"120355"	61.42	-0.75
+NA	NA	NA	"120442"	48.41	2.92
+NA	NA	NA	"120506"	30.59	-4.76
+NA	NA	NA	"120601"	75.02	0.01
+NA	NA	NA	"120875"	47.68	1.91
+NA	NA	NA	"120886"	31.36	-2.1
+NA	NA	NA	"120900"	61.03	8.12
+NA	NA	NA	"120985"	36.85	7.02
+NA	NA	NA	"120999"	10.88	-0.88
+NA	NA	NA	"121038"	44.99	0.86
+NA	NA	NA	"121082"	79.98	2.17
+NA	NA	NA	"121100"	71.16	3.2
+NA	NA	NA	"121173"	22.96	6.21
+NA	NA	NA	"121241"	67.12	3.14
+NA	NA	NA	"121324"	58.96	-0.18
+NA	NA	NA	"121345"	19.26	-2.74
+NA	NA	NA	"121371"	0.17	-0.69
+NA	NA	NA	"121736"	4.8	5.13
+NA	NA	NA	"121883"	81.66	2.58
+NA	NA	NA	"130007"	72.57	8.08
+NA	NA	NA	"130087"	61.45	0.13
+NA	NA	NA	"130108"	70.33	-1.76
+NA	NA	NA	"130153"	79.61	6.97
+NA	NA	NA	"130155"	8.57	-3.91
+NA	NA	NA	"130158"	76.73	-1.39
+NA	NA	NA	"130190"	26.01	0.87
+NA	NA	NA	"130213"	59.72	3.5
+NA	NA	NA	"130225"	55.3	-0.14
+NA	NA	NA	"130227"	87.54	0.64
+NA	NA	NA	"130272"	70.93	1.15
+NA	NA	NA	"130339"	19.46	0.52
+NA	NA	NA	"130363"	70.4	1.53
+NA	NA	NA	"130465"	79.36	-3.75
+NA	NA	NA	"130466"	86.08	-3.9
+NA	NA	NA	"130477"	32.02	5.36
+NA	NA	NA	"130488"	61.04	-1.22
+NA	NA	NA	"130577"	39.31	-1.6
+NA	NA	NA	"130600"	57.3	4.51
+NA	NA	NA	"130630"	31.4	0.64
+NA	NA	NA	"130722"	48.54	4.93
+NA	NA	NA	"130786"	69.51	-2.33
+NA	NA	NA	"130793"	47.61	1.62
+NA	NA	NA	"130847"	49.48	6.84
+NA	NA	NA	"130868"	6.45	7.61
+NA	NA	NA	"130947"	64.94	-4
+NA	NA	NA	"130995"	38.36	-0.34
+NA	NA	NA	"131059"	33.33	7.21
+NA	NA	NA	"131092"	61.89	4.24
+NA	NA	NA	"131152"	7.88	4.2
+NA	NA	NA	"131200"	27.89	-3.68
+NA	NA	NA	"131203"	12.83	-3.79
+NA	NA	NA	"131260"	32.59	6.83
+NA	NA	NA	"131263"	13.36	7.74
+NA	NA	NA	"131268"	62.24	3.61
+NA	NA	NA	"140071"	73.33	2.86
+NA	NA	NA	"140099"	81.38	4.94
+NA	NA	NA	"140105"	76.66	-3.98
+NA	NA	NA	"140180"	70.7	0.45
+NA	NA	NA	"140197"	21.38	-0.05
+NA	NA	NA	"140243"	25.97	0.16
+NA	NA	NA	"140246"	61.25	6.26
+NA	NA	NA	"140289"	10.59	2.4
+NA	NA	NA	"140310"	0.9	3.12
+NA	NA	NA	"140388"	46.91	0.33
+NA	NA	NA	"140396"	42.13	-0.84
+NA	NA	NA	"140399"	68.89	3.79
+NA	NA	NA	"140417"	41.97	0.24
+NA	NA	NA	"140461"	10.19	-3.73
+NA	NA	NA	"140497"	7.85	-3.2
+NA	NA	NA	"140530"	55.3	2.4
+NA	NA	NA	"140726"	13.39	5.31
+NA	NA	NA	"140764"	67.95	3.72
+NA	NA	NA	"140822"	81.12	-1.16
+NA	NA	NA	"140872"	86.5	-1.79
+NA	NA	NA	"140929"	87.84	-3.02
+NA	NA	NA	"140933"	33.96	3.07
+NA	NA	NA	"140980"	82.04	0.21
+NA	NA	NA	"141011"	50.81	-0.5
+NA	NA	NA	"141110"	1.79	5.89
+NA	NA	NA	"141328"	33.22	-4.62
+NA	NA	NA	"141351"	27.67	4.37
+NA	NA	NA	"141400"	43.88	-3.96
+NA	NA	NA	"150198"	72.01	-2.68
+NA	NA	NA	"150526"	56.24	-3.17
+NA	NA	NA	"150600"	74.17	4.32
+NA	NA	NA	"150618"	16.27	4.45
+NA	NA	NA	"150807"	62.44	-1.22
+NA	NA	NA	"150977"	50.13	-3.79
+NA	NA	NA	"150983"	50.23	3.46
+NA	NA	NA	"151129"	45.69	1.31
+NA	NA	NA	"151219"	35.44	-2.31
+NA	NA	NA	"160119"	26.75	-4.44
+NA	NA	NA	"160141"	3.33	-1.74
+NA	NA	NA	"160151"	5.27	2.29
+NA	NA	NA	"160229"	74.61	5.25
+NA	NA	NA	"160234"	63.91	-2.65
+NA	NA	NA	"160488"	7.32	-3.88
+NA	NA	NA	"160500"	70.66	-4.07
+NA	NA	NA	"160569"	36.41	5.26
+NA	NA	NA	"160618"	58.08	6.06
+NA	NA	NA	"160734"	42.5	1.75
+NA	NA	NA	"160784"	24.72	-4.71
+NA	NA	NA	"160845"	15.01	5.45
+NA	NA	NA	"160862"	18.67	5.09
+NA	NA	NA	"161054"	7.05	-2.4
+NA	NA	NA	"161063"	48.17	5.64
+NA	NA	NA	"170023"	26.33	4.1
+NA	NA	NA	"170060"	45.46	3.9
+NA	NA	NA	"170081"	76.4	7.88
+NA	NA	NA	"170088"	19.83	0.64
+NA	NA	NA	"170240"	80.23	1.72
+NA	NA	NA	"170321"	60.08	7.14
+NA	NA	NA	"170475"	68.12	-0.44
+NA	NA	NA	"170479"	4.04	5.87
+NA	NA	NA	"170513"	41.63	-2.16
+NA	NA	NA	"170516"	81.39	0.3
+NA	NA	NA	"170538"	13.14	-3.13
+NA	NA	NA	"170553"	27.84	8.1
+NA	NA	NA	"170554"	24.79	-1.02
+NA	NA	NA	"170596"	77.24	6.94
+NA	NA	NA	"170806"	76.27	-0.45
+NA	NA	NA	"170816"	66.99	3.91
+NA	NA	NA	"170845"	43.6	-0.37
+NA	NA	NA	"170854"	7.77	2.5
+NA	NA	NA	"170862"	50.47	8.11
+NA	NA	NA	"170890"	17.43	-2.18
+NA	NA	NA	"170999"	21.79	-1.41
+NA	NA	NA	"171063"	67.52	2.49
+NA	NA	NA	"171573"	15.55	-0.7
+NA	NA	NA	"171584"	13.88	-4.62
+NA	NA	NA	"171596"	63.46	3.86
+NA	NA	NA	"171660"	65.62	-0.74
+NA	NA	NA	"171704"	82.75	-3.7
+NA	NA	NA	"180440"	22.32	7.03
+NA	NA	NA	"180667"	31.11	1.41
+NA	NA	NA	"181009"	62.39	5.21
+NA	NA	NA	"181209"	26.49	5.11
+NA	NA	NA	"181675"	26.87	3.05
+NA	NA	NA	"190051"	17.01	-3.86
+NA	NA	NA	"190128"	17.13	7.78
+NA	NA	NA	"190420"	36.91	-1.66
+NA	NA	NA	"190437"	38.16	0.45
+NA	NA	NA	"190448"	4.08	7.51
+NA	NA	NA	"190470"	19.85	5.83
+NA	NA	NA	"190581"	59.05	6.09
+NA	NA	NA	"190651"	67.2	-2.92
+NA	NA	NA	"190699"	62.13	-2.35
+NA	NA	NA	"190708"	28.42	6.27
+NA	NA	NA	"190772"	5	-2.4
+NA	NA	NA	"190780"	11.41	-2.09
+NA	NA	NA	"190820"	52.67	-3.3
+NA	NA	NA	"190832"	39.04	-3.63
+NA	NA	NA	"190873"	81.29	-0.54
+NA	NA	NA	"190907"	15.36	6.72
+NA	NA	NA	"190912"	14.46	2.74
+NA	NA	NA	"190942"	58.72	-0.19
+NA	NA	NA	"190946"	21.66	6.67
+NA	NA	NA	"190988"	21.84	7.16
+NA	NA	NA	"190996"	72.54	3.09
+NA	NA	NA	"191023"	22.6	0.99
+NA	NA	NA	"191024"	71.48	-4.81
+NA	NA	NA	"191047"	17.49	5.21
+NA	NA	NA	"191055"	85.76	6.62
+NA	NA	NA	"191096"	17.86	-0.35
+NA	NA	NA	"191136"	13.01	0.42
+NA	NA	NA	"191140"	63.21	-4.64
+NA	NA	NA	"191187"	83.81	5.18
+NA	NA	NA	"191212"	83.25	1.47
+NA	NA	NA	"191218"	10.14	5.82
+NA	NA	NA	"191283"	67.04	3.78
+NA	NA	NA	"191304"	24.96	0.68
+NA	NA	NA	"191305"	8.87	-4.91
+NA	NA	NA	"191307"	0.54	7.21
+NA	NA	NA	"191341"	88.57	1.66
+NA	NA	NA	"191354"	64.04	-3.87
+NA	NA	NA	"191372"	4.73	6.25
+NA	NA	NA	"191397"	17.41	0.4
+NA	NA	NA	"210234"	36.81	1.64
+NA	NA	NA	"210257"	3.14	-4.1
+NA	NA	NA	"210258"	45	-4.05
+NA	NA	NA	"210259"	28.84	5.27
+NA	NA	NA	"210261"	26.52	2.22
+NA	NA	NA	"210282"	31.19	3.66
+NA	NA	NA	"210528"	46.98	4.6
+NA	NA	NA	"210565"	38.89	2.39
+NA	NA	NA	"210696"	82.18	8.06
+NA	NA	NA	"210750"	35.27	-4.52
+NA	NA	NA	"210863"	71.3	4.85
+NA	NA	NA	"210864"	83.33	4.48
+NA	NA	NA	"210869"	24.79	2.94
+NA	NA	NA	"210914"	44.27	4.73
+NA	NA	NA	"211015"	51.08	1.03
+NA	NA	NA	"211075"	8.45	5.77
+NA	NA	NA	"211165"	36.17	-2.85
+NA	NA	NA	"211376"	31.78	7.6
+NA	NA	NA	"211434"	54.04	5.46
+NA	NA	NA	"211498"	33.38	2.71
+NA	NA	NA	"211621"	16.94	4.91
+NA	NA	NA	"211815"	63.32	3.22
+NA	NA	NA	"211835"	7.81	-4.55
+NA	NA	NA	"212014"	76.07	6.07
+NA	NA	NA	"212054"	86.03	4.33
+NA	NA	NA	"212189"	32.45	1.93
+NA	NA	NA	"220080"	53.85	5.47
+NA	NA	NA	"220099"	0.31	2.13
+NA	NA	NA	"220196"	55.41	-1.43
+NA	NA	NA	"220375"	30	5.18
+NA	NA	NA	"220430"	30.83	-4.91
+NA	NA	NA	"220545"	52.02	4.5
+NA	NA	NA	"220583"	25.88	-0.62
+NA	NA	NA	"220595"	37.63	-1.15
+NA	NA	NA	"220657"	48.11	4.26
+NA	NA	NA	"220750"	30.26	7.05
+NA	NA	NA	"220810"	45.52	5.11
+NA	NA	NA	"220814"	14.19	-1.66
+NA	NA	NA	"220901"	23.65	2.62
+NA	NA	NA	"220963"	66	0.25
+NA	NA	NA	"221082"	40.67	4.26
+NA	NA	NA	"221175"	51.56	3.99
+NA	NA	NA	"221212"	58.28	-0.44
+NA	NA	NA	"221328"	60.17	3.34
+NA	NA	NA	"221486"	38.11	-0.42
+NA	NA	NA	"221631"	25.1	3.14
+NA	NA	NA	"230068"	73.38	0.8
+NA	NA	NA	"230157"	46.95	3.34
+NA	NA	NA	"230174"	62.95	-2.04
+NA	NA	NA	"230222"	15.13	2.97
+NA	NA	NA	"230389"	69.86	-0.27
+NA	NA	NA	"230414"	11.43	7.17
+NA	NA	NA	"230437"	60.15	4.5
+NA	NA	NA	"230439"	50.73	0.67
+NA	NA	NA	"230515"	20.72	5.5
+NA	NA	NA	"230530"	85.49	3.16
+NA	NA	NA	"230601"	81.52	5.24
+NA	NA	NA	"230679"	26.59	-2.31
+NA	NA	NA	"230724"	43.83	-4.1
+NA	NA	NA	"230729"	74.41	4.89
+NA	NA	NA	"230866"	75.68	-1.32
+NA	NA	NA	"230913"	69.64	5.86
+NA	NA	NA	"231011"	79.68	0.86
+NA	NA	NA	"231097"	0.59	0.42
+NA	NA	NA	"231345"	25.3	-1.01
+NA	NA	NA	"240115"	41.36	6.75
+NA	NA	NA	"240782"	54.58	1.41
+NA	NA	NA	"240854"	38.98	4.68
+NA	NA	NA	"241165"	0.74	4.37
+NA	NA	NA	"241657"	22.48	2.09
+NA	NA	NA	"241666"	9.68	4.59
+NA	NA	NA	"241724"	58.01	7.56
+NA	NA	NA	"242007"	76.59	0.79
+NA	NA	NA	"250067"	85.02	2.43
+NA	NA	NA	"250175"	48.03	-1.16
+NA	NA	NA	"250327"	32.06	7
+NA	NA	NA	"250383"	75.96	5.33
+NA	NA	NA	"250406"	54.08	0.69
+NA	NA	NA	"250484"	72.95	-4.15
+NA	NA	NA	"250503"	39.01	-0.94
+NA	NA	NA	"250664"	58.67	-3.43
+NA	NA	NA	"250685"	4.69	1.88
+NA	NA	NA	"250698"	31.04	-4.21
+NA	NA	NA	"250791"	23.41	5.07
+NA	NA	NA	"250815"	28.78	-2.41
+NA	NA	NA	"250839"	81.37	-4.03
+NA	NA	NA	"250843"	2.32	-0.53
+NA	NA	NA	"250907"	18.99	4.56
+NA	NA	NA	"251005"	74.76	6.16
+NA	NA	NA	"251102"	14.39	-1.46
+NA	NA	NA	"251146"	21.71	1.53
+NA	NA	NA	"251176"	63.67	1.49
+NA	NA	NA	"251210"	70.19	0.66
+NA	NA	NA	"260041"	21.94	0.72
+NA	NA	NA	"260304"	77.5	-0.27
+NA	NA	NA	"260313"	61.55	3
+NA	NA	NA	"260323"	7.3	-3.27
+NA	NA	NA	"260325"	82.67	-2.2
+NA	NA	NA	"260364"	57.68	0.71
+NA	NA	NA	"260426"	61.7	4.37
+NA	NA	NA	"260558"	31.1	2.03
+NA	NA	NA	"260582"	80.34	-1.82
+NA	NA	NA	"260593"	82.15	5.54
+NA	NA	NA	"260729"	35.56	-4.18
+NA	NA	NA	"261018"	78.6	-3.91
+NA	NA	NA	"261248"	77.86	0.46
+NA	NA	NA	"261330"	52.08	-2.31
+NA	NA	NA	"261390"	9.4	-1
+NA	NA	NA	"261529"	52.79	-3.73
+NA	NA	NA	"270069"	63.47	0.78
+NA	NA	NA	"270112"	17.11	-1.14
+NA	NA	NA	"270129"	53.6	-0.97
+NA	NA	NA	"270151"	49.64	-2.79
+NA	NA	NA	"270167"	84.48	0.36
+NA	NA	NA	"270187"	12.94	-0.13
+NA	NA	NA	"270257"	85.5	-3.73
+NA	NA	NA	"270258"	1.79	6.23
+NA	NA	NA	"270320"	23.01	0.44
+NA	NA	NA	"270387"	80.83	7.54
+NA	NA	NA	"270426"	12.57	7.4
+NA	NA	NA	"270497"	65.06	6.67
+NA	NA	NA	"270516"	25.23	3.94
+NA	NA	NA	"270537"	52.15	-4.33
+NA	NA	NA	"270561"	23.83	3.28
+NA	NA	NA	"270575"	9.82	5.43
+NA	NA	NA	"270660"	12.98	-2.88
+NA	NA	NA	"270679"	76.34	3.55
+NA	NA	NA	"270684"	72.6	-1.55
+NA	NA	NA	"270694"	68.04	3.36
+NA	NA	NA	"270707"	23.95	6.57
+NA	NA	NA	"270842"	24.68	-0.73
+NA	NA	NA	"270847"	47.57	-4.16
+NA	NA	NA	"271106"	18.93	5.01
+NA	NA	NA	"271125"	34.49	0.07
+NA	NA	NA	"271214"	13.01	4.34
+NA	NA	NA	"271350"	87.58	4.22
+NA	NA	NA	"271360"	56.33	7.62
+NA	NA	NA	"271371"	51.75	3.06
+NA	NA	NA	"271436"	58.1	-3.11
+NA	NA	NA	"271511"	27.94	-2.44
+NA	NA	NA	"280294"	40.7	-1.91
+NA	NA	NA	"280335"	59.45	7.87
+NA	NA	NA	"280425"	15.97	-1.66
+NA	NA	NA	"280623"	15.04	-4.63
+NA	NA	NA	"280740"	58.73	5.03
+NA	NA	NA	"281003"	40.92	2.64
+NA	NA	NA	"281065"	88.85	-1.66
+NA	NA	NA	"281111"	16.79	-4.94
+NA	NA	NA	"290004"	9.92	-1.57
+NA	NA	NA	"290087"	29.36	-0.83
+NA	NA	NA	"290118"	49.75	-2.13
+NA	NA	NA	"290243"	72.17	-1.08
+NA	NA	NA	"290321"	21.03	-4.97
+NA	NA	NA	"290416"	12.53	5.11
+NA	NA	NA	"290419"	2.98	-1.74
+NA	NA	NA	"290435"	61.27	-3.81
+NA	NA	NA	"290458"	68.72	-2.43
+NA	NA	NA	"290523"	7.16	7.52
+NA	NA	NA	"290629"	76.87	1.65
+NA	NA	NA	"290644"	31.87	2.41
+NA	NA	NA	"290709"	40.44	-3.87
+NA	NA	NA	"290810"	13.43	1.47
+NA	NA	NA	"291139"	12	2.39
+NA	NA	NA	"291233"	60.27	-3.32
+NA	NA	NA	"291426"	73.36	6.85
+NA	NA	NA	"2B0586"	57.43	2.14
+NA	NA	NA	"300111"	78.14	2.6
+NA	NA	NA	"300144"	58.23	3.48
+NA	NA	NA	"300167"	21.62	6.68
+NA	NA	NA	"300229"	31.08	-4.21
+NA	NA	NA	"300286"	85.18	7.76
+NA	NA	NA	"300293"	24.23	-1.93
+NA	NA	NA	"300307"	87.75	3.88
+NA	NA	NA	"300471"	6.57	-3.42
+NA	NA	NA	"300547"	58.2	2.29
+NA	NA	NA	"300598"	81.42	6.78
+NA	NA	NA	"300617"	7.51	5.77
+NA	NA	NA	"300728"	63.97	3.58
+NA	NA	NA	"300731"	56.12	0.71
+NA	NA	NA	"300764"	16.18	-1.19
+NA	NA	NA	"300776"	69.28	-4.41
+NA	NA	NA	"300786"	31.78	-4.38
+NA	NA	NA	"300825"	52.29	7.94
+NA	NA	NA	"300863"	37.14	7.2
+NA	NA	NA	"300867"	43.22	-1.48
+NA	NA	NA	"300894"	23.31	4.14
+NA	NA	NA	"301007"	44.06	0.49
+NA	NA	NA	"301045"	82.52	-3.18
+NA	NA	NA	"301069"	81.87	-4.29
+NA	NA	NA	"301146"	21.75	5.53
+NA	NA	NA	"301194"	8.94	7.22
+NA	NA	NA	"301254"	22.13	4.31
+NA	NA	NA	"301272"	67.04	-0.24
+NA	NA	NA	"301323"	18.65	-1.12
+NA	NA	NA	"301330"	70.7	4.13
+NA	NA	NA	"310224"	30.44	-4.8
+NA	NA	NA	"310359"	65.01	3.27
+NA	NA	NA	"310610"	87.77	0.21
+NA	NA	NA	"310721"	44.46	2.34
+NA	NA	NA	"311361"	65.63	1.57
+NA	NA	NA	"311365"	11.03	5.19
+NA	NA	NA	"311406"	33.91	6.21
+NA	NA	NA	"311453"	63.28	-0.89
+NA	NA	NA	"311508"	54.11	3.11
+NA	NA	NA	"311574"	6.23	6
+NA	NA	NA	"320202"	65.96	-1.28
+NA	NA	NA	"320898"	4.81	0.98
+NA	NA	NA	"320905"	73.61	2.18
+NA	NA	NA	"320960"	60.9	-3.75
+NA	NA	NA	"321154"	35.59	0.44
+NA	NA	NA	"321407"	49.98	-2.22
+NA	NA	NA	"330150"	30.57	2.45
+NA	NA	NA	"330257"	3.8	-4.34
+NA	NA	NA	"330421"	32.34	7.17
+NA	NA	NA	"330706"	84.81	7.55
+NA	NA	NA	"330718"	4.95	7.25
+NA	NA	NA	"330741"	64.43	-2.02
+NA	NA	NA	"331212"	14.97	7.78
+NA	NA	NA	"331313"	60.68	1.31
+NA	NA	NA	"331332"	57.24	2.84
+NA	NA	NA	"331346"	44.17	0.95
+NA	NA	NA	"331358"	22.61	0.33
+NA	NA	NA	"331369"	60.22	2.11
+NA	NA	NA	"331432"	53.62	6.05
+NA	NA	NA	"331464"	10.56	4.71
+NA	NA	NA	"331508"	41.2	1.5
+NA	NA	NA	"331572"	6.32	-0.04
+NA	NA	NA	"331588"	24.37	1.71
+NA	NA	NA	"331634"	72.05	3.09
+NA	NA	NA	"331667"	12.5	-1.94
+NA	NA	NA	"331668"	27.52	-1.69
+NA	NA	NA	"331717"	61.97	-3.66
+NA	NA	NA	"331806"	85.38	8.1
+NA	NA	NA	"331855"	87.6	3.65
+NA	NA	NA	"331879"	10.06	3
+NA	NA	NA	"340049"	17.28	-0.49
+NA	NA	NA	"340059"	16.35	1.63
+NA	NA	NA	"340085"	90	2.06
+NA	NA	NA	"340086"	84.47	0.5
+NA	NA	NA	"340131"	63.07	5.35
+NA	NA	NA	"340187"	41.57	-4.5
+NA	NA	NA	"340245"	36.53	0.23
+NA	NA	NA	"340257"	18.23	1.78
+NA	NA	NA	"340370"	73.99	-4.68
+NA	NA	NA	"340406"	56.73	-2.85
+NA	NA	NA	"340456"	86.54	4.78
+NA	NA	NA	"340586"	34.36	-3.49
+NA	NA	NA	"340636"	19.19	3.77
+NA	NA	NA	"340680"	60.76	6.08
+NA	NA	NA	"340691"	26.97	3.04
+NA	NA	NA	"340817"	73.95	3.76
+NA	NA	NA	"340883"	60.63	-3.38
+NA	NA	NA	"340985"	12.73	-0.17
+NA	NA	NA	"341087"	50.42	-4.44
+NA	NA	NA	"341388"	76.68	-4.59
+NA	NA	NA	"341447"	24.2	4.11
+NA	NA	NA	"341547"	14.1	4.91
+NA	NA	NA	"350050"	60.43	0.02
+NA	NA	NA	"350096"	42.9	4.45
+NA	NA	NA	"350148"	50.36	3.67
+NA	NA	NA	"350155"	20.73	2.89
+NA	NA	NA	"350259"	85.37	1.11
+NA	NA	NA	"350344"	68.66	0.92
+NA	NA	NA	"350393"	58.28	-1.29
+NA	NA	NA	"350503"	10.86	4.23
+NA	NA	NA	"350506"	58.48	2.71
+NA	NA	NA	"350605"	13.61	3.74
+NA	NA	NA	"350611"	75.78	5.36
+NA	NA	NA	"350633"	58.31	-4.06
+NA	NA	NA	"350746"	20.92	1.46
+NA	NA	NA	"350815"	14.17	-4.67
+NA	NA	NA	"350822"	26.7	3.74
+NA	NA	NA	"350825"	8.9	-1.32
+NA	NA	NA	"350829"	88.99	-0.51
+NA	NA	NA	"350870"	67.62	0.71
+NA	NA	NA	"350962"	33.31	1.42
+NA	NA	NA	"350977"	79.7	6.92
+NA	NA	NA	"351015"	86.09	-1.53
+NA	NA	NA	"351024"	54	-2.63
+NA	NA	NA	"351054"	8.15	0.92
+NA	NA	NA	"351126"	17.92	-4.81
+NA	NA	NA	"351208"	45.82	-4.52
+NA	NA	NA	"351215"	42.72	1.99
+NA	NA	NA	"351224"	19.05	0.22
+NA	NA	NA	"351333"	58.9	4.91
+NA	NA	NA	"351408"	62.87	-2.75
+NA	NA	NA	"351496"	30.97	3.88
+NA	NA	NA	"351598"	61.31	4.82
+NA	NA	NA	"351649"	80.34	4.73
+NA	NA	NA	"360945"	3.71	0.19
+NA	NA	NA	"361326"	23.23	-2.66
+NA	NA	NA	"370081"	81.86	6.33
+NA	NA	NA	"370113"	70.88	1.77
+NA	NA	NA	"370373"	64.09	-3.02
+NA	NA	NA	"370506"	44.91	-2.98
+NA	NA	NA	"370742"	26.85	6.39
+NA	NA	NA	"370777"	40.24	4.99
+NA	NA	NA	"370844"	63.73	7
+NA	NA	NA	"371051"	77.01	0.42
+NA	NA	NA	"380099"	66.97	-0.02
+NA	NA	NA	"380117"	42.63	-0.33
+NA	NA	NA	"380212"	22.41	-4.51
+NA	NA	NA	"380234"	87.7	2.49
+NA	NA	NA	"380286"	53.5	-2.83
+NA	NA	NA	"380511"	4.99	-3.4
+NA	NA	NA	"380522"	46.14	3.43
+NA	NA	NA	"380654"	70.7	3.21
+NA	NA	NA	"380729"	66.11	3.97
+NA	NA	NA	"380999"	52.46	4.97
+NA	NA	NA	"381082"	71.4	-1.61
+NA	NA	NA	"381146"	74.27	-4.75
+NA	NA	NA	"381152"	73.05	-3.12
+NA	NA	NA	"381186"	72.81	5.52
+NA	NA	NA	"381313"	86.58	6.14
+NA	NA	NA	"381338"	68.14	7.67
+NA	NA	NA	"381350"	50.98	3.17
+NA	NA	NA	"381425"	10.31	3.76
+NA	NA	NA	"381498"	36.96	6.25
+NA	NA	NA	"381622"	58.49	6.99
+NA	NA	NA	"381656"	58.76	7.25
+NA	NA	NA	"381777"	76.16	7.22
+NA	NA	NA	"390051"	50.1	5.63
+NA	NA	NA	"390299"	69.18	2.52
+NA	NA	NA	"390310"	89.59	1.5
+NA	NA	NA	"390403"	25.1	-4.46
+NA	NA	NA	"390424"	63.44	-4.54
+NA	NA	NA	"390425"	74.52	1.71
+NA	NA	NA	"390437"	58.13	3.71
+NA	NA	NA	"390455"	9.06	7
+NA	NA	NA	"390475"	42.45	-3.99
+NA	NA	NA	"390527"	52.42	6.14
+NA	NA	NA	"390564"	1.45	4.2
+NA	NA	NA	"390695"	52.59	-4.16
+NA	NA	NA	"390743"	22.55	3.46
+NA	NA	NA	"390746"	15.81	-0.16
+NA	NA	NA	"390793"	83.07	3.43
+NA	NA	NA	"390849"	26.01	7.37
+NA	NA	NA	"390969"	24.15	-0.24
+NA	NA	NA	"391042"	50.43	0.47
+NA	NA	NA	"391083"	76.9	5.97
+NA	NA	NA	"391098"	16.76	5.62
+NA	NA	NA	"391163"	73.62	-3.77
+NA	NA	NA	"400093"	66.04	4.14
+NA	NA	NA	"400294"	59.7	3.07
+NA	NA	NA	"400695"	74.68	7.87
+NA	NA	NA	"401297"	50.69	-4.2
+NA	NA	NA	"401325"	23.35	-1.24
+NA	NA	NA	"401467"	38.81	-4.29
+NA	NA	NA	"401489"	63.27	0.91
+NA	NA	NA	"401638"	83.66	6.13
+NA	NA	NA	"401840"	58.55	0.58
+NA	NA	NA	"402163"	21.53	3.12
+NA	NA	NA	"402164"	14.94	3.62
+NA	NA	NA	"402194"	18.01	4.99
+NA	NA	NA	"402259"	57.61	-0.13
+NA	NA	NA	"402359"	84.41	3.55
+NA	NA	NA	"410065"	9.39	7.64
+NA	NA	NA	"410160"	47.62	0.79
+NA	NA	NA	"410212"	9.61	-3.15
+NA	NA	NA	"410354"	56.47	-2.05
+NA	NA	NA	"410770"	9.87	-3.63
+NA	NA	NA	"410869"	60.52	1.48
+NA	NA	NA	"410996"	41.15	-4.78
+NA	NA	NA	"411018"	79.08	6.4
+NA	NA	NA	"411373"	19.85	2.89
+NA	NA	NA	"420482"	60.96	5.17
+NA	NA	NA	"420637"	79.06	0.14
+NA	NA	NA	"420714"	53.38	4.64
+NA	NA	NA	"420726"	57.61	-4.38
+NA	NA	NA	"420729"	33.39	4.7
+NA	NA	NA	"420816"	86.53	-0.1
+NA	NA	NA	"420867"	84.72	0.97
+NA	NA	NA	"420938"	53.23	2.6
+NA	NA	NA	"420985"	50.76	1.04
+NA	NA	NA	"421002"	63.33	-0.81
+NA	NA	NA	"421050"	59.64	0.35
+NA	NA	NA	"421055"	65.13	6.69
+NA	NA	NA	"421161"	27.35	0.22
+NA	NA	NA	"421165"	67.39	7.72
+NA	NA	NA	"430036"	15.26	1.46
+NA	NA	NA	"430173"	35.57	-4.09
+NA	NA	NA	"430197"	49.51	4.89
+NA	NA	NA	"430312"	58.55	-4.59
+NA	NA	NA	"430568"	71.37	4.06
+NA	NA	NA	"430603"	49.57	6.89
+NA	NA	NA	"430741"	89.52	-4.47
+NA	NA	NA	"430772"	80.38	6.02
+NA	NA	NA	"430816"	54.8	3.95
+NA	NA	NA	"431220"	15.93	3.14
+NA	NA	NA	"431260"	42.62	1.9
+NA	NA	NA	"440235"	78.67	-3.48
+NA	NA	NA	"440308"	66.26	4.37
+NA	NA	NA	"440398"	72.7	5.82
+NA	NA	NA	"440430"	67.89	2.94
+NA	NA	NA	"440456"	45.28	6.48
+NA	NA	NA	"440462"	6.06	1.77
+NA	NA	NA	"440660"	77.89	6.77
+NA	NA	NA	"440817"	43.92	6.32
+NA	NA	NA	"440993"	4.27	3.33
+NA	NA	NA	"441031"	23.18	3.15
+NA	NA	NA	"441048"	16.59	-4.06
+NA	NA	NA	"441061"	35.87	3.9
+NA	NA	NA	"441153"	37.73	5.6
+NA	NA	NA	"441233"	52.26	-0.09
+NA	NA	NA	"441236"	32.08	-4.53
+NA	NA	NA	"441265"	6.11	6.63
+NA	NA	NA	"441427"	89.8	3.44
+NA	NA	NA	"441558"	2.09	-0.38
+NA	NA	NA	"441594"	7.35	7.96
+NA	NA	NA	"441612"	54.78	3.21
+NA	NA	NA	"441640"	61.54	-1.43
+NA	NA	NA	"450029"	57.08	3.45
+NA	NA	NA	"450118"	13.18	6.69
+NA	NA	NA	"450125"	25.17	5.16
+NA	NA	NA	"450445"	11.64	-3.76
+NA	NA	NA	"450473"	64.55	-3.34
+NA	NA	NA	"450562"	60.73	4
+NA	NA	NA	"450615"	53.16	2.3
+NA	NA	NA	"450673"	7.13	-4.81
+NA	NA	NA	"450725"	32.78	3.27
+NA	NA	NA	"450781"	89.04	5.69
+NA	NA	NA	"450793"	27.22	3.21
+NA	NA	NA	"450828"	74.86	0.89
+NA	NA	NA	"450846"	19.6	-2.15
+NA	NA	NA	"450847"	11.52	5.35
+NA	NA	NA	"450877"	11.01	-2.48
+NA	NA	NA	"450902"	79.67	4.01
+NA	NA	NA	"450910"	76.36	-2.43
+NA	NA	NA	"450934"	2.28	2.17
+NA	NA	NA	"451010"	27.22	3.57
+NA	NA	NA	"451018"	8.14	-3.27
+NA	NA	NA	"451111"	86.84	-4.07
+NA	NA	NA	"451122"	35.62	2.1
+NA	NA	NA	"451138"	58.04	6.87
+NA	NA	NA	"451293"	66.17	0.68
+NA	NA	NA	"451478"	81.09	6.78
+NA	NA	NA	"451691"	20.23	5.94
+NA	NA	NA	"460082"	69.4	4.75
+NA	NA	NA	"461014"	34.28	3.15
+NA	NA	NA	"461114"	24.12	-1.89
+NA	NA	NA	"461195"	17.7	-4.85
+NA	NA	NA	"470461"	14.72	4.08
+NA	NA	NA	"470914"	89.78	1.02
+NA	NA	NA	"480272"	55.21	3.85
+NA	NA	NA	"480300"	34.79	5.34
+NA	NA	NA	"480338"	48.6	0
+NA	NA	NA	"480624"	85.26	-0.59
+NA	NA	NA	"480628"	41.6	4.05
+NA	NA	NA	"480715"	72.25	5.5
+NA	NA	NA	"480838"	12.55	7.21
+NA	NA	NA	"480980"	89.9	6.68
+NA	NA	NA	"480996"	25.17	4.19
+NA	NA	NA	"481147"	24.31	-2.47
+NA	NA	NA	"481158"	36.59	-4.65
+NA	NA	NA	"481182"	69.67	7.01
+NA	NA	NA	"481186"	51.18	4.92
+NA	NA	NA	"481258"	81.45	2.47
+NA	NA	NA	"490063"	13.54	0.15
+NA	NA	NA	"490123"	63.13	5.34
+NA	NA	NA	"490174"	73.01	-2.62
+NA	NA	NA	"490249"	88.54	-4.87
+NA	NA	NA	"490270"	8.1	3.07
+NA	NA	NA	"490350"	31.33	4.68
+NA	NA	NA	"490369"	38.28	7.58
+NA	NA	NA	"490427"	44.74	-0.25
+NA	NA	NA	"490457"	89.54	0.84
+NA	NA	NA	"490512"	13.69	7.58
+NA	NA	NA	"490613"	32.48	-2.19
+NA	NA	NA	"490614"	17.69	-1.17
+NA	NA	NA	"490649"	30.14	7.13
+NA	NA	NA	"490653"	44.99	-1.66
+NA	NA	NA	"490739"	0.16	-2.46
+NA	NA	NA	"490783"	73.58	-0.47
+NA	NA	NA	"490820"	62.89	-2.71
+NA	NA	NA	"490857"	83.55	-0.02
+NA	NA	NA	"490859"	70.74	1.22
+NA	NA	NA	"490867"	2.79	2.42
+NA	NA	NA	"490903"	54.31	-1.36
+NA	NA	NA	"490914"	58.65	5.61
+NA	NA	NA	"490953"	60.11	4.43
+NA	NA	NA	"490980"	45.82	2.03
+NA	NA	NA	"491015"	61.4	5.94
+NA	NA	NA	"491022"	9.35	-0.62
+NA	NA	NA	"491051"	43.28	-3.05
+NA	NA	NA	"491094"	88.39	-3.18
+NA	NA	NA	"491121"	82.06	0.07
+NA	NA	NA	"491129"	38.14	-3.85
+NA	NA	NA	"491305"	53.14	1.63
+NA	NA	NA	"491356"	27.73	3.51
+NA	NA	NA	"491451"	10.61	2.38
+NA	NA	NA	"491594"	26.5	1.88
+NA	NA	NA	"491596"	46.51	6.43
+NA	NA	NA	"491648"	89.71	1.44
+NA	NA	NA	"491679"	87.36	1.71
+NA	NA	NA	"491718"	57.55	-0.28
+NA	NA	NA	"491729"	33.53	4.37
+NA	NA	NA	"491757"	72.33	1.49
+NA	NA	NA	"491762"	66.36	-2.08
+NA	NA	NA	"500035"	55.56	-1.77
+NA	NA	NA	"500037"	46.38	-1.22
+NA	NA	NA	"500060"	44.22	4.72
+NA	NA	NA	"500063"	86.28	-1.3
+NA	NA	NA	"500159"	81.71	2.15
+NA	NA	NA	"500271"	45.24	-0.4
+NA	NA	NA	"500302"	46.66	-0.19
+NA	NA	NA	"500371"	12.59	4.39
+NA	NA	NA	"500445"	36.41	-0.74
+NA	NA	NA	"500626"	83.94	-1.83
+NA	NA	NA	"500989"	25.96	5.32
+NA	NA	NA	"501180"	3.47	-4.77
+NA	NA	NA	"510015"	33.38	5.34
+NA	NA	NA	"510115"	10.46	-0.86
+NA	NA	NA	"510204"	56.76	1.96
+NA	NA	NA	"510230"	31.27	6.68
+NA	NA	NA	"510688"	84.99	6.35
+NA	NA	NA	"510693"	66.44	4
+NA	NA	NA	"510789"	55.32	7.68
+NA	NA	NA	"510825"	30.42	2.35
+NA	NA	NA	"510851"	37.3	0.06
+NA	NA	NA	"510865"	5.61	1.11
+NA	NA	NA	"510976"	22.33	3.21
+NA	NA	NA	"510982"	42.6	0.14
+NA	NA	NA	"511152"	4.08	7.97
+NA	NA	NA	"511246"	12.96	-1.49
+NA	NA	NA	"511284"	67.48	-1.34
+NA	NA	NA	"511429"	14.51	-2.74
+NA	NA	NA	"511454"	45.87	6.86
+NA	NA	NA	"511466"	50.08	-1.08
+NA	NA	NA	"511549"	75.51	6.14
+NA	NA	NA	"511751"	10.5	-1.51
+NA	NA	NA	"511788"	17.97	-0.63
+NA	NA	NA	"511791"	5.59	1.65
+NA	NA	NA	"511831"	11.78	-0.48
+NA	NA	NA	"511945"	53.78	4.51
+NA	NA	NA	"512030"	60.36	5.24
+NA	NA	NA	"520002"	1.73	-0.2
+NA	NA	NA	"520030"	68.35	-3.48
+NA	NA	NA	"520052"	78.06	2.34
+NA	NA	NA	"520074"	68.41	4.76
+NA	NA	NA	"520134"	83.13	-0.87
+NA	NA	NA	"520740"	28.85	1.59
+NA	NA	NA	"520854"	35.55	-0.05
+NA	NA	NA	"520894"	41.22	2.34
+NA	NA	NA	"520983"	56.17	1.99
+NA	NA	NA	"521019"	76.99	-0.44
+NA	NA	NA	"521056"	63.4	-2.3
+NA	NA	NA	"521187"	18.73	3.53
+NA	NA	NA	"521201"	86.61	8.17
+NA	NA	NA	"530249"	87.43	1.39
+NA	NA	NA	"530337"	18.8	4.57
+NA	NA	NA	"530508"	15.01	4.11
+NA	NA	NA	"530544"	24.74	7.33
+NA	NA	NA	"530656"	1.33	2.14
+NA	NA	NA	"530687"	35.12	1.92
+NA	NA	NA	"530806"	3.61	-1
+NA	NA	NA	"530828"	32.81	-0.29
+NA	NA	NA	"531111"	29.04	-4.88
+NA	NA	NA	"540004"	87.93	3.73
+NA	NA	NA	"540014"	82.08	-4.2
+NA	NA	NA	"540129"	67.55	3.3
+NA	NA	NA	"540267"	10.76	5.71
+NA	NA	NA	"540288"	83.52	1.9
+NA	NA	NA	"540327"	80.44	6.35
+NA	NA	NA	"540339"	75.36	7.42
+NA	NA	NA	"540436"	80.97	0.5
+NA	NA	NA	"540453"	46.03	-4.77
+NA	NA	NA	"540593"	76.53	0.01
+NA	NA	NA	"540619"	86.57	6.91
+NA	NA	NA	"540660"	86.92	-4.05
+NA	NA	NA	"540689"	50.46	5.97
+NA	NA	NA	"540690"	55.68	7.28
+NA	NA	NA	"540784"	1.56	4.5
+NA	NA	NA	"540812"	6.98	-1.43
+NA	NA	NA	"541292"	78.43	-2.21
+NA	NA	NA	"550035"	19.26	-2.6
+NA	NA	NA	"550057"	36.99	5.51
+NA	NA	NA	"550166"	28.49	6.94
+NA	NA	NA	"550357"	65	3.1
+NA	NA	NA	"550387"	19.77	3.94
+NA	NA	NA	"550441"	82.16	-4.69
+NA	NA	NA	"550482"	52.66	-3.46
+NA	NA	NA	"550893"	14.19	3.86
+NA	NA	NA	"550903"	11.08	5
+NA	NA	NA	"551024"	48.29	0.98
+NA	NA	NA	"551032"	67.99	-4.89
+NA	NA	NA	"551158"	75.68	-3.78
+NA	NA	NA	"551159"	57.96	7.73
+NA	NA	NA	"551211"	37.61	5.24
+NA	NA	NA	"551212"	11.84	-1
+NA	NA	NA	"551257"	17.47	-4.88
+NA	NA	NA	"551426"	40.03	-2.84
+NA	NA	NA	"551428"	27.46	-2.77
+NA	NA	NA	"551432"	52.88	-2.58
+NA	NA	NA	"551445"	5.97	7.54
+NA	NA	NA	"551466"	23.71	-3.19
+NA	NA	NA	"551468"	86.75	5.16
+NA	NA	NA	"551487"	57.84	6.8
+NA	NA	NA	"551491"	26.72	-4.37
+NA	NA	NA	"551493"	68.36	4.06
+NA	NA	NA	"551507"	11.21	-2.18
+NA	NA	NA	"551521"	62.61	-0.34
+NA	NA	NA	"560003"	56.03	5.17
+NA	NA	NA	"560005"	13.89	-2.12
+NA	NA	NA	"560402"	71.79	1.35
+NA	NA	NA	"560443"	34.82	5.84
+NA	NA	NA	"560456"	2.96	-4.87
+NA	NA	NA	"560510"	50.06	-1.06
+NA	NA	NA	"560662"	13.82	3.06
+NA	NA	NA	"560799"	50.33	4.7
+NA	NA	NA	"560819"	20.55	3.1
+NA	NA	NA	"560888"	72.81	-4.37
+NA	NA	NA	"560931"	87.66	0.11
+NA	NA	NA	"560988"	80.12	-1.42
+NA	NA	NA	"561037"	11.78	-4.74
+NA	NA	NA	"561043"	1.71	3.6
+NA	NA	NA	"561250"	44.45	5.28
+NA	NA	NA	"561302"	13.74	0.12
+NA	NA	NA	"561388"	89.91	0.15
+NA	NA	NA	"561460"	1.75	-4.7
+NA	NA	NA	"561475"	69.79	-4.76
+NA	NA	NA	"570157"	80.74	-2.42
+NA	NA	NA	"570225"	71.48	-3.59
+NA	NA	NA	"570305"	47.53	5.22
+NA	NA	NA	"570424"	45.1	-4
+NA	NA	NA	"570482"	51.39	7.72
+NA	NA	NA	"570639"	84.73	-4.51
+NA	NA	NA	"570945"	80.91	-1.04
+NA	NA	NA	"571294"	85.3	-3.82
+NA	NA	NA	"571327"	86.37	-4.8
+NA	NA	NA	"580019"	4.93	5.73
+NA	NA	NA	"580129"	35.59	4.41
+NA	NA	NA	"580152"	59.24	-4.74
+NA	NA	NA	"580166"	77.5	-1.92
+NA	NA	NA	"580172"	28.81	7.03
+NA	NA	NA	"580179"	40.81	-1.64
+NA	NA	NA	"580351"	35.61	7.57
+NA	NA	NA	"580541"	42.04	-3.46
+NA	NA	NA	"580571"	9.49	4.64
+NA	NA	NA	"580578"	88.17	6.24
+NA	NA	NA	"580591"	70.04	-1.4
+NA	NA	NA	"580644"	4.57	8.1
+NA	NA	NA	"580655"	66.38	6.99
+NA	NA	NA	"580805"	19.28	0.6
+NA	NA	NA	"580853"	79.85	5.19
+NA	NA	NA	"580882"	65.57	6.97
+NA	NA	NA	"580900"	23.41	-2.26
+NA	NA	NA	"580991"	56.02	-1.61
+NA	NA	NA	"581024"	67.43	4.41
+NA	NA	NA	"581085"	0.48	1.85
+NA	NA	NA	"581218"	83.45	-4.05
+NA	NA	NA	"581261"	84.5	5.47
+NA	NA	NA	"581360"	0.14	7.64
+NA	NA	NA	"581367"	36.84	4.28
+NA	NA	NA	"581384"	3.14	-2.58
+NA	NA	NA	"581391"	42.77	4.67
+NA	NA	NA	"581398"	50.74	-1.43
+NA	NA	NA	"581409"	19.95	-3.03
+NA	NA	NA	"581459"	5.23	-4.07
+NA	NA	NA	"581488"	72.55	0.69
+NA	NA	NA	"590013"	14.79	-3.37
+NA	NA	NA	"590029"	29.23	4.57
+NA	NA	NA	"590043"	15.76	-2.16
+NA	NA	NA	"590050"	47.01	5.81
+NA	NA	NA	"590061"	40.05	-3.71
+NA	NA	NA	"590090"	67.86	2.77
+NA	NA	NA	"590117"	65.86	0.01
+NA	NA	NA	"590121"	78.41	5.87
+NA	NA	NA	"590138"	81.61	-0.16
+NA	NA	NA	"590155"	80.36	-0.83
+NA	NA	NA	"590198"	2.74	-1.65
+NA	NA	NA	"590326"	89.65	0.12
+NA	NA	NA	"590453"	51.85	1.35
+NA	NA	NA	"590500"	18.38	-1.2
+NA	NA	NA	"590536"	53.53	-0.85
+NA	NA	NA	"590541"	81.6	-0.2
+NA	NA	NA	"590564"	19.82	6.19
+NA	NA	NA	"590565"	15.55	1.14
+NA	NA	NA	"590696"	15.61	-2.51
+NA	NA	NA	"590698"	8.14	7.4
+NA	NA	NA	"591139"	12.46	7.51
+NA	NA	NA	"591146"	80.27	5.4
+NA	NA	NA	"591374"	68.2	3.32
+NA	NA	NA	"600373"	81.12	-2.08
+NA	NA	NA	"600378"	34.68	-0.73
+NA	NA	NA	"600693"	56.49	4.03
+NA	NA	NA	"600711"	43.5	2.41
+NA	NA	NA	"600753"	24.14	1.18
+NA	NA	NA	"600779"	62.84	0.09
+NA	NA	NA	"600781"	57.1	0.39
+NA	NA	NA	"600782"	8.03	-4.51
+NA	NA	NA	"600816"	25.81	2.16
+NA	NA	NA	"600896"	29.84	-4.86
+NA	NA	NA	"600921"	26.27	-4.59
+NA	NA	NA	"600925"	36.25	6.23
+NA	NA	NA	"600975"	45.19	7.5
+NA	NA	NA	"601042"	13.89	-4.61
+NA	NA	NA	"601133"	65.7	5.67
+NA	NA	NA	"601165"	45.36	-1.9
+NA	NA	NA	"601247"	14.59	6.63
+NA	NA	NA	"601276"	22.54	1.76
+NA	NA	NA	"601279"	74.27	2.55
+NA	NA	NA	"601372"	60.23	-0.05
+NA	NA	NA	"601376"	41.58	4.3
+NA	NA	NA	"610045"	85.62	-4.22
+NA	NA	NA	"610139"	12.04	-1.28
+NA	NA	NA	"610236"	42.73	-3.93
+NA	NA	NA	"610294"	46.91	-1.3
+NA	NA	NA	"610341"	12.38	5.72
+NA	NA	NA	"610685"	74.29	-2.29
+NA	NA	NA	"611045"	38.3	6.42
+NA	NA	NA	"611139"	73.96	1.4
+NA	NA	NA	"611239"	12.99	-2.45
+NA	NA	NA	"611260"	16.15	-1.8
+NA	NA	NA	"611313"	88.02	3.64
+NA	NA	NA	"611344"	61.57	-4.17
+NA	NA	NA	"611393"	49.76	-4.5
+NA	NA	NA	"611464"	23.14	4.29
+NA	NA	NA	"620032"	0.07	5.56
+NA	NA	NA	"620040"	54.16	5.06
+NA	NA	NA	"620065"	68.21	-1.79
+NA	NA	NA	"620082"	70.81	-2.58
+NA	NA	NA	"620092"	19.01	1.3
+NA	NA	NA	"620105"	51.01	3.12
+NA	NA	NA	"620111"	77.59	0.26
+NA	NA	NA	"620155"	86.99	7.33
+NA	NA	NA	"620183"	30.12	-4.67
+NA	NA	NA	"620186"	88.66	-4.04
+NA	NA	NA	"620190"	54.58	0.94
+NA	NA	NA	"620251"	33.13	1.44
+NA	NA	NA	"620259"	40.89	5.43
+NA	NA	NA	"620291"	88.8	-4.33
+NA	NA	NA	"620345"	35.87	5.66
+NA	NA	NA	"620369"	87.53	7
+NA	NA	NA	"620372"	60.16	1.37
+NA	NA	NA	"620394"	42.86	-2.39
+NA	NA	NA	"620507"	7.78	2.45
+NA	NA	NA	"620528"	54.84	-2.42
+NA	NA	NA	"620599"	11.92	-3.18
+NA	NA	NA	"620616"	88.16	2.07
+NA	NA	NA	"620618"	70.84	2.7
+NA	NA	NA	"620846"	72.14	7.64
+NA	NA	NA	"620868"	41.12	5.15
+NA	NA	NA	"620879"	81.01	-1.78
+NA	NA	NA	"620888"	75.07	3.98
+NA	NA	NA	"620893"	70.32	7.61
+NA	NA	NA	"620898"	48.87	-1.49
+NA	NA	NA	"621078"	26.46	-3.85
+NA	NA	NA	"621110"	67.38	-2.55
+NA	NA	NA	"621177"	10.86	5.05
+NA	NA	NA	"621190"	67.86	4.1
+NA	NA	NA	"621274"	58.78	-1.98
+NA	NA	NA	"621284"	39.42	-0.89
+NA	NA	NA	"621298"	15.89	-4.81
+NA	NA	NA	"621312"	70.05	1.96
+NA	NA	NA	"621314"	51.27	3.68
+NA	NA	NA	"621319"	7.48	-2.19
+NA	NA	NA	"621355"	88.58	-3.77
+NA	NA	NA	"621359"	87.09	-2.69
+NA	NA	NA	"621360"	66.42	2.94
+NA	NA	NA	"621372"	13.45	-3.2
+NA	NA	NA	"630079"	40.12	-2.26
+NA	NA	NA	"630156"	28.4	-2.67
+NA	NA	NA	"630239"	2.57	-3.24
+NA	NA	NA	"630329"	35.57	-0.68
+NA	NA	NA	"630355"	88.88	-3.87
+NA	NA	NA	"630357"	61.09	-3.71
+NA	NA	NA	"630367"	16.71	6.56
+NA	NA	NA	"630369"	47.03	-3.18
+NA	NA	NA	"630421"	38.83	3.25
+NA	NA	NA	"630448"	11.55	-3.48
+NA	NA	NA	"630453"	89.17	-3.24
+NA	NA	NA	"630503"	30.9	5.88
+NA	NA	NA	"630551"	16.62	2.77
+NA	NA	NA	"630638"	49.79	5.66
+NA	NA	NA	"630694"	54.13	3.49
+NA	NA	NA	"630698"	26.69	3.65
+NA	NA	NA	"630972"	56.71	-0.32
+NA	NA	NA	"631199"	52.89	1.35
+NA	NA	NA	"631250"	45.39	4.49
+NA	NA	NA	"631306"	77.45	-4.96
+NA	NA	NA	"631309"	40.07	-2.16
+NA	NA	NA	"631428"	58.64	-1.81
+NA	NA	NA	"631825"	14.8	0.45
+NA	NA	NA	"640075"	30.26	0.82
+NA	NA	NA	"640101"	69.94	-4.59
+NA	NA	NA	"640125"	59.91	3.56
+NA	NA	NA	"640251"	27.08	6.17
+NA	NA	NA	"640254"	50.23	5.5
+NA	NA	NA	"640600"	73.87	3.08
+NA	NA	NA	"640644"	44	3.49
+NA	NA	NA	"640936"	89.15	-2.1
+NA	NA	NA	"641018"	59.5	-3.78
+NA	NA	NA	"641555"	27.02	6.51
+NA	NA	NA	"641647"	65.28	2.03
+NA	NA	NA	"641648"	27.9	-0.4
+NA	NA	NA	"650066"	30.63	6.63
+NA	NA	NA	"650278"	8.99	-0.93
+NA	NA	NA	"650329"	81.99	-1.47
+NA	NA	NA	"650477"	30.15	4.63
+NA	NA	NA	"650489"	11.8	-1.01
+NA	NA	NA	"650492"	32.61	7.94
+NA	NA	NA	"650502"	89.15	4.33
+NA	NA	NA	"650569"	23.19	-3.48
+NA	NA	NA	"650987"	14.55	8.08
+NA	NA	NA	"651062"	42.19	-3.71
+NA	NA	NA	"660011"	13.8	-2.69
+NA	NA	NA	"660050"	71.36	-1.63
+NA	NA	NA	"660134"	89.53	5.97
+NA	NA	NA	"660330"	59.59	7.34
+NA	NA	NA	"660335"	36.87	-0.8
+NA	NA	NA	"660453"	17.7	4.06
+NA	NA	NA	"660539"	22.45	1.01
+NA	NA	NA	"660649"	58.22	-4.52
+NA	NA	NA	"660895"	61.63	-0.57
+NA	NA	NA	"660994"	34.66	-4.65
+NA	NA	NA	"670208"	83.86	-4.49
+NA	NA	NA	"670559"	38.09	-1.54
+NA	NA	NA	"670560"	30.39	-2.54
+NA	NA	NA	"670561"	6.35	0.18
+NA	NA	NA	"670562"	59.26	-4.89
+NA	NA	NA	"670563"	31.9	5.85
+NA	NA	NA	"670564"	65.6	-4.31
+NA	NA	NA	"670566"	37.63	0.85
+NA	NA	NA	"670568"	56.76	2
+NA	NA	NA	"670569"	53.02	4.18
+NA	NA	NA	"670570"	33.03	-4.15
+NA	NA	NA	"670701"	22.86	3.86
+NA	NA	NA	"670725"	84.54	4.67
+NA	NA	NA	"670991"	88.5	-3.24
+NA	NA	NA	"680049"	65.92	-3.45
+NA	NA	NA	"680465"	6.04	7.41
+NA	NA	NA	"680490"	61.35	4.88
+NA	NA	NA	"680648"	38.42	-4.3
+NA	NA	NA	"680664"	17.77	2.25
+NA	NA	NA	"690072"	24.44	5.66
+NA	NA	NA	"690127"	21.76	-0.11
+NA	NA	NA	"690205"	28.45	-1.31
+NA	NA	NA	"690297"	1.83	-3.89
+NA	NA	NA	"690336"	65.07	2.08
+NA	NA	NA	"690388"	44.54	8.14
+NA	NA	NA	"690415"	44.93	-3
+NA	NA	NA	"690462"	55.93	3.37
+NA	NA	NA	"690492"	18.57	5.24
+NA	NA	NA	"690518"	22.02	-4.02
+NA	NA	NA	"690525"	86.42	5.19
+NA	NA	NA	"690544"	65.15	4.7
+NA	NA	NA	"690546"	19.98	-0.57
+NA	NA	NA	"690559"	39.71	-2.88
+NA	NA	NA	"690560"	80.48	-3.42
+NA	NA	NA	"690570"	10.78	7.72
+NA	NA	NA	"690575"	56.65	0.48
+NA	NA	NA	"690592"	47.28	3.33
+NA	NA	NA	"690631"	3.66	1.65
+NA	NA	NA	"690639"	27.16	1.67
+NA	NA	NA	"690642"	33.94	-0.37
+NA	NA	NA	"690760"	34.28	1.76
+NA	NA	NA	"690775"	47.67	3.63
+NA	NA	NA	"690786"	83.51	-0.68
+NA	NA	NA	"700216"	52.13	1.22
+NA	NA	NA	"700313"	70.64	-1.36
+NA	NA	NA	"700415"	63.78	6.87
+NA	NA	NA	"700419"	76.52	5.26
+NA	NA	NA	"700578"	81.16	1.45
+NA	NA	NA	"700783"	5.73	-1.47
+NA	NA	NA	"700784"	40.81	0.83
+NA	NA	NA	"700802"	54.03	5.99
+NA	NA	NA	"700928"	0.98	2.31
+NA	NA	NA	"701232"	29.69	-0.23
+NA	NA	NA	"701329"	83.55	4.04
+NA	NA	NA	"710031"	29.38	-0.97
+NA	NA	NA	"710034"	40.45	3.99
+NA	NA	NA	"710090"	32.17	-1.06
+NA	NA	NA	"710191"	37.52	1.03
+NA	NA	NA	"710237"	29.3	7.99
+NA	NA	NA	"710259"	17.43	-2.95
+NA	NA	NA	"710305"	31.27	0.96
+NA	NA	NA	"710312"	4.37	-4.77
+NA	NA	NA	"710319"	48.62	0.82
+NA	NA	NA	"710333"	0.55	5.39
+NA	NA	NA	"710340"	51.87	2.49
+NA	NA	NA	"710441"	79.85	-2.26
+NA	NA	NA	"710483"	27.22	-4.17
+NA	NA	NA	"710586"	44.7	6.85
+NA	NA	NA	"710642"	32.15	3.58
+NA	NA	NA	"710647"	79.44	7.36
+NA	NA	NA	"710735"	35.59	4.78
+NA	NA	NA	"710828"	64.62	5.32
+NA	NA	NA	"710835"	78.19	8.01
+NA	NA	NA	"710853"	63.52	6.59
+NA	NA	NA	"710860"	87.28	2.7
+NA	NA	NA	"710873"	88.74	0.98
+NA	NA	NA	"710883"	46.78	3.1
+NA	NA	NA	"710906"	32.88	0.84
+NA	NA	NA	"710913"	73.67	-3.9
+NA	NA	NA	"710941"	65.6	5.06
+NA	NA	NA	"711152"	72.19	-4.49
+NA	NA	NA	"711221"	7.08	2.96
+NA	NA	NA	"711460"	20.17	-3.51
+NA	NA	NA	"711480"	32.67	-2.44
+NA	NA	NA	"711501"	65.79	5.96
+NA	NA	NA	"711508"	80.64	-4.87
+NA	NA	NA	"711528"	74.47	1.59
+NA	NA	NA	"711529"	51.67	2.31
+NA	NA	NA	"711553"	28.09	6.75
+NA	NA	NA	"711915"	75.17	-1.14
+NA	NA	NA	"711922"	71.37	2.47
+NA	NA	NA	"711929"	18.44	-2.84
+NA	NA	NA	"711961"	54.33	3.83
+NA	NA	NA	"711968"	77.98	-4.56
+NA	NA	NA	"712004"	23.88	2.69
+NA	NA	NA	"712053"	73.85	4.11
+NA	NA	NA	"720034"	29.06	0.84
+NA	NA	NA	"720042"	37.89	1.33
+NA	NA	NA	"720134"	32.09	-4.32
+NA	NA	NA	"720282"	74.89	-0.99
+NA	NA	NA	"720322"	41.75	2.3
+NA	NA	NA	"720485"	56.61	6.25
+NA	NA	NA	"720511"	39.65	1.44
+NA	NA	NA	"720691"	10.48	-2.15
+NA	NA	NA	"720724"	28.18	3.35
+NA	NA	NA	"720799"	61.15	-0.76
+NA	NA	NA	"720815"	66.91	6.21
+NA	NA	NA	"720983"	75.06	7.43
+NA	NA	NA	"721170"	84.37	7.44
+NA	NA	NA	"721179"	48.6	-1.79
+NA	NA	NA	"730171"	47.12	6.48
+NA	NA	NA	"730256"	87.6	4.08
+NA	NA	NA	"730535"	84.03	-2.92
+NA	NA	NA	"730575"	38.27	-3.06
+NA	NA	NA	"730622"	89.33	4.02
+NA	NA	NA	"730628"	17.36	5.02
+NA	NA	NA	"730833"	59.18	-0.85
+NA	NA	NA	"730939"	25.75	7.56
+NA	NA	NA	"731111"	4.83	-1.79
+NA	NA	NA	"731248"	87.23	0.81
+NA	NA	NA	"731323"	29.34	6.77
+NA	NA	NA	"731395"	69.99	4.19
+NA	NA	NA	"731398"	26.99	4.24
+NA	NA	NA	"740003"	29.97	4.73
+NA	NA	NA	"740004"	27.97	1
+NA	NA	NA	"740019"	20.31	7.1
+NA	NA	NA	"740020"	13.7	-0.09
+NA	NA	NA	"740028"	37.14	4.1
+NA	NA	NA	"740029"	58.58	4.75
+NA	NA	NA	"740030"	74.78	-2.42
+NA	NA	NA	"740033"	49.55	6.07
+NA	NA	NA	"740046"	61.84	-0.75
+NA	NA	NA	"740144"	21.88	6.94
+NA	NA	NA	"740413"	55.21	-0.43
+NA	NA	NA	"740885"	6.29	-3.12
+NA	NA	NA	"740904"	56.79	6
+NA	NA	NA	"740983"	66.93	4.02
+NA	NA	NA	"741019"	59.98	-2.38
+NA	NA	NA	"750002"	84.12	-2.75
+NA	NA	NA	"750003"	56.18	2.65
+NA	NA	NA	"750004"	20.95	6.65
+NA	NA	NA	"750005"	9.99	6.24
+NA	NA	NA	"750006"	72.94	0.38
+NA	NA	NA	"750010"	4.85	2.61
+NA	NA	NA	"750011"	25.24	3.99
+NA	NA	NA	"750017"	49.1	2.83
+NA	NA	NA	"750019"	53.29	0.22
+NA	NA	NA	"750022"	73.55	0.83
+NA	NA	NA	"750026"	10.3	7.24
+NA	NA	NA	"760023"	82.64	-4.88
+NA	NA	NA	"760029"	59.61	2.8
+NA	NA	NA	"760038"	36.52	-2.34
+NA	NA	NA	"760055"	59.41	2.65
+NA	NA	NA	"760152"	37.63	2.08
+NA	NA	NA	"760197"	60.86	2.38
+NA	NA	NA	"760226"	62.52	2.03
+NA	NA	NA	"760289"	59.75	6.35
+NA	NA	NA	"760325"	25.38	4.18
+NA	NA	NA	"760326"	52.69	-4.63
+NA	NA	NA	"760343"	34.18	3.69
+NA	NA	NA	"760396"	84.51	6.51
+NA	NA	NA	"760401"	30.37	7.87
+NA	NA	NA	"760497"	65.69	-4.42
+NA	NA	NA	"760515"	66.91	-1.58
+NA	NA	NA	"760654"	3.03	1.27
+NA	NA	NA	"760684"	17.62	-0.08
+NA	NA	NA	"760742"	33.42	-3.32
+NA	NA	NA	"760822"	36.8	-1.83
+NA	NA	NA	"760921"	46.75	-0.19
+NA	NA	NA	"760941"	23.16	6.25
+NA	NA	NA	"760962"	51.9	5.44
+NA	NA	NA	"761060"	57.2	5.15
+NA	NA	NA	"761079"	29.92	3.63
+NA	NA	NA	"761116"	21.09	2.82
+NA	NA	NA	"761163"	67.17	0.8
+NA	NA	NA	"761174"	73.66	-4.31
+NA	NA	NA	"761206"	61.12	4.29
+NA	NA	NA	"761250"	4.14	6.06
+NA	NA	NA	"761263"	25.67	2.77
+NA	NA	NA	"761357"	23.3	-4.38
+NA	NA	NA	"761404"	67.67	-2.68
+NA	NA	NA	"761476"	59.52	0.08
+NA	NA	NA	"761507"	88.15	8.07
+NA	NA	NA	"761561"	66	-1.9
+NA	NA	NA	"770002"	1.43	7.12
+NA	NA	NA	"770007"	73.09	-3.23
+NA	NA	NA	"770008"	17.68	3.38
+NA	NA	NA	"770013"	25.91	-3.34
+NA	NA	NA	"770014"	82.7	-2.39
+NA	NA	NA	"770056"	63.38	5.45
+NA	NA	NA	"770059"	24.02	6.68
+NA	NA	NA	"770066"	14.73	-1.95
+NA	NA	NA	"770071"	72.16	3.96
+NA	NA	NA	"770086"	85.55	7.19
+NA	NA	NA	"770153"	87.45	-2.42
+NA	NA	NA	"770172"	84.74	7.11
+NA	NA	NA	"770230"	21.15	7.32
+NA	NA	NA	"770243"	77.57	4.41
+NA	NA	NA	"770275"	69.44	-1.83
+NA	NA	NA	"770286"	31.23	-1.7
+NA	NA	NA	"770292"	51.49	-4.54
+NA	NA	NA	"770318"	37.19	-3.45
+NA	NA	NA	"770368"	41.82	3.19
+NA	NA	NA	"770389"	71.46	0.9
+NA	NA	NA	"770391"	44.68	6.19
+NA	NA	NA	"770392"	50.09	6.66
+NA	NA	NA	"770496"	86.82	6.22
+NA	NA	NA	"770504"	74.15	0
+NA	NA	NA	"770541"	75.52	-1.92
+NA	NA	NA	"770581"	6.37	4.49
+NA	NA	NA	"770594"	85.04	1.66
+NA	NA	NA	"770601"	56.38	-0.42
+NA	NA	NA	"770652"	77.49	-3.69
+NA	NA	NA	"770754"	27.25	-0.88
+NA	NA	NA	"770759"	29.72	5.49
+NA	NA	NA	"770779"	83.23	2.82
+NA	NA	NA	"770798"	38.42	-2.64
+NA	NA	NA	"770820"	23.5	-1.72
+NA	NA	NA	"770837"	15.6	0.58
+NA	NA	NA	"770879"	53.58	3.91
+NA	NA	NA	"770951"	85.85	-2.94
+NA	NA	NA	"770970"	89.72	1.82
+NA	NA	NA	"771000"	55.75	1.42
+NA	NA	NA	"771010"	41.89	1.77
+NA	NA	NA	"771012"	6.01	1.5
+NA	NA	NA	"771037"	48.3	3.62
+NA	NA	NA	"771061"	31.64	2.69
+NA	NA	NA	"771136"	83.93	5.82
+NA	NA	NA	"771152"	74.41	-2.74
+NA	NA	NA	"771164"	56.16	-3.16
+NA	NA	NA	"771191"	58.99	-4.29
+NA	NA	NA	"771192"	36.16	4.61
+NA	NA	NA	"771206"	52.67	-3.96
+NA	NA	NA	"771274"	24.34	2.62
+NA	NA	NA	"771312"	11.22	-3.93
+NA	NA	NA	"771320"	31.58	-4.15
+NA	NA	NA	"771423"	32.21	7.44
+NA	NA	NA	"771447"	37	0.42
+NA	NA	NA	"771463"	12.41	-0.35
+NA	NA	NA	"780023"	84	-0.68
+NA	NA	NA	"780024"	18.76	3.24
+NA	NA	NA	"780043"	14.98	-2.63
+NA	NA	NA	"780048"	60.95	6.77
+NA	NA	NA	"780103"	28.07	3.18
+NA	NA	NA	"780106"	30.75	-1.11
+NA	NA	NA	"780152"	64.61	-0.54
+NA	NA	NA	"780155"	71.22	-1.58
+NA	NA	NA	"780171"	42.66	0.15
+NA	NA	NA	"780192"	46.25	2.85
+NA	NA	NA	"780264"	21.94	4.34
+NA	NA	NA	"780294"	6.05	-0.74
+NA	NA	NA	"780297"	48.81	-0.71
+NA	NA	NA	"780383"	14.89	4.2
+NA	NA	NA	"780394"	41.8	-1.86
+NA	NA	NA	"780437"	13.37	1.49
+NA	NA	NA	"780513"	50.84	-1.95
+NA	NA	NA	"780537"	2.84	-2.19
+NA	NA	NA	"780566"	62.22	7.36
+NA	NA	NA	"790400"	17.71	0.09
+NA	NA	NA	"790457"	37.86	-2.52
+NA	NA	NA	"790536"	70.37	0.3
+NA	NA	NA	"790569"	65.08	4.43
+NA	NA	NA	"790596"	33.98	-2.77
+NA	NA	NA	"790642"	28.41	4.78
+NA	NA	NA	"790732"	71.7	3.55
+NA	NA	NA	"790747"	73.79	0.78
+NA	NA	NA	"790784"	51.42	4.85
+NA	NA	NA	"790979"	11.67	-4.57
+NA	NA	NA	"791041"	5.58	5.78
+NA	NA	NA	"791048"	47.38	7.7
+NA	NA	NA	"791054"	51.59	-2.59
+NA	NA	NA	"791094"	80.78	0.97
+NA	NA	NA	"791115"	69.24	-4.91
+NA	NA	NA	"791125"	23.36	-4.99
+NA	NA	NA	"791130"	77.88	2.57
+NA	NA	NA	"791230"	50.46	0.67
+NA	NA	NA	"791304"	16.32	-2.36
+NA	NA	NA	"791340"	20.22	4.39
+NA	NA	NA	"791363"	72.25	5.1
+NA	NA	NA	"791435"	19.25	-2.49
+NA	NA	NA	"791454"	19.59	-3.05
+NA	NA	NA	"800060"	15.92	1.84
+NA	NA	NA	"800074"	4.76	7.98
+NA	NA	NA	"800123"	21.78	1
+NA	NA	NA	"800413"	55.8	4.63
+NA	NA	NA	"800445"	15.45	5
+NA	NA	NA	"800455"	25.61	1.64
+NA	NA	NA	"800594"	60.5	0.92
+NA	NA	NA	"800649"	85.61	6.74
+NA	NA	NA	"800816"	6.92	6.02
+NA	NA	NA	"800825"	68.27	-3.34
+NA	NA	NA	"800861"	23.09	1.18
+NA	NA	NA	"800869"	24.55	-2.04
+NA	NA	NA	"801067"	76.79	0.83
+NA	NA	NA	"801072"	23.19	1.76
+NA	NA	NA	"801119"	33.26	5.31
+NA	NA	NA	"801435"	81.92	-2.59
+NA	NA	NA	"810124"	4.69	5.65
+NA	NA	NA	"810147"	66.14	6.32
+NA	NA	NA	"810275"	72.69	5.57
+NA	NA	NA	"810325"	40.52	-3.36
+NA	NA	NA	"810551"	59.26	2.78
+NA	NA	NA	"810937"	82.2	7.41
+NA	NA	NA	"811145"	3.81	-4.22
+NA	NA	NA	"811158"	56.95	7.89
+NA	NA	NA	"811261"	4.57	1.96
+NA	NA	NA	"811441"	13.14	-4.79
+NA	NA	NA	"820034"	70.39	7.49
+NA	NA	NA	"820074"	80.83	-1.03
+NA	NA	NA	"820168"	57.36	-2.03
+NA	NA	NA	"820174"	69.95	4.64
+NA	NA	NA	"820244"	16.98	-1.53
+NA	NA	NA	"820263"	86.06	2.33
+NA	NA	NA	"820714"	56.62	7.21
+NA	NA	NA	"830056"	36.73	2.41
+NA	NA	NA	"830254"	67.86	7.55
+NA	NA	NA	"830317"	0.33	1.63
+NA	NA	NA	"830519"	69.57	-0.19
+NA	NA	NA	"830629"	82.68	-1.7
+NA	NA	NA	"830720"	29.27	-0.46
+NA	NA	NA	"830722"	8.94	-3.48
+NA	NA	NA	"830738"	89.47	1.86
+NA	NA	NA	"830807"	34.54	1.7
+NA	NA	NA	"830965"	66.79	-1.86
+NA	NA	NA	"830986"	78.27	-0.34
+NA	NA	NA	"831009"	38.17	1.37
+NA	NA	NA	"831021"	67.64	5.69
+NA	NA	NA	"831063"	51.09	3.46
+NA	NA	NA	"831070"	55.28	-3.86
+NA	NA	NA	"831112"	32.02	2.91
+NA	NA	NA	"831123"	52.03	-3.83
+NA	NA	NA	"831140"	49.16	1.16
+NA	NA	NA	"831147"	8.44	2.7
+NA	NA	NA	"831220"	41.44	-0.26
+NA	NA	NA	"831238"	56.12	-0.24
+NA	NA	NA	"831259"	83.42	-3.04
+NA	NA	NA	"831265"	65.29	5.94
+NA	NA	NA	"831314"	23.33	4.36
+NA	NA	NA	"831360"	46.39	1.64
+NA	NA	NA	"831371"	84.42	5.83
+NA	NA	NA	"831419"	38.38	1.14
+NA	NA	NA	"831433"	12.89	4.92
+NA	NA	NA	"831435"	0.01	-1.25
+NA	NA	NA	"831462"	77.72	0.24
+NA	NA	NA	"831524"	66.17	0.51
+NA	NA	NA	"840028"	30.23	-4.87
+NA	NA	NA	"840061"	68.5	4.72
+NA	NA	NA	"840102"	22.53	-4.63
+NA	NA	NA	"840151"	58.55	1.31
+NA	NA	NA	"840172"	43.71	-2.37
+NA	NA	NA	"840192"	44.04	3.16
+NA	NA	NA	"840228"	77.55	5.14
+NA	NA	NA	"840368"	2.55	6.14
+NA	NA	NA	"840500"	46.51	2.58
+NA	NA	NA	"840512"	17.51	-4.47
+NA	NA	NA	"840550"	71.86	2.03
+NA	NA	NA	"840572"	64.35	-0.53
+NA	NA	NA	"840599"	0.05	7.87
+NA	NA	NA	"840634"	24.28	-2.95
+NA	NA	NA	"840655"	23.95	5.47
+NA	NA	NA	"840685"	26.33	7.74
+NA	NA	NA	"840765"	75.57	5.36
+NA	NA	NA	"850005"	29.1	8.02
+NA	NA	NA	"850010"	76.6	3.63
+NA	NA	NA	"850032"	79.39	6.71
+NA	NA	NA	"850068"	51.63	-4.5
+NA	NA	NA	"850095"	45.56	2.3
+NA	NA	NA	"850107"	52.35	-0.54
+NA	NA	NA	"850167"	82.27	2.07
+NA	NA	NA	"850217"	42.08	-1.38
+NA	NA	NA	"850218"	81.02	0.83
+NA	NA	NA	"850219"	76.11	6.29
+NA	NA	NA	"850268"	40.48	2.46
+NA	NA	NA	"850290"	56.22	4.54
+NA	NA	NA	"850446"	17.5	-4.7
+NA	NA	NA	"850521"	89.08	-4.31
+NA	NA	NA	"850568"	63.18	-1.49
+NA	NA	NA	"850605"	11.99	-2.61
+NA	NA	NA	"850626"	74.92	3.5
+NA	NA	NA	"850737"	81.79	-0.48
+NA	NA	NA	"850771"	32.72	-1.28
+NA	NA	NA	"850781"	85.62	1.55
+NA	NA	NA	"850788"	18.18	1.47
+NA	NA	NA	"850802"	33.53	4.63
+NA	NA	NA	"850815"	9.84	2.1
+NA	NA	NA	"850828"	1.59	4.36
+NA	NA	NA	"850947"	11.49	-0.72
+NA	NA	NA	"850960"	32.64	3.77
+NA	NA	NA	"851105"	51.82	4.99
+NA	NA	NA	"851134"	30.05	6.76
+NA	NA	NA	"851224"	3.74	4.69
+NA	NA	NA	"851229"	40.88	-3.85
+NA	NA	NA	"851251"	45.67	1.72
+NA	NA	NA	"851313"	58.76	4.68
+NA	NA	NA	"851366"	50.37	4.6
+NA	NA	NA	"851421"	77.61	1.36
+NA	NA	NA	"851489"	56.94	6.3
+NA	NA	NA	"851508"	11.57	-1.36
+NA	NA	NA	"851577"	15.7	6.72
+NA	NA	NA	"860010"	10.89	-0.29
+NA	NA	NA	"860106"	22.16	2.71
+NA	NA	NA	"860163"	22.15	5.91
+NA	NA	NA	"860303"	33.98	7.48
+NA	NA	NA	"860368"	44.34	8.03
+NA	NA	NA	"860372"	59.91	-2.47
+NA	NA	NA	"860380"	57.06	1.03
+NA	NA	NA	"860508"	85.11	4.41
+NA	NA	NA	"860511"	79.56	1.56
+NA	NA	NA	"860569"	42.03	-2.41
+NA	NA	NA	"860594"	15.67	3.87
+NA	NA	NA	"860647"	67.21	-1.26
+NA	NA	NA	"860750"	10.19	-2.92
+NA	NA	NA	"860794"	19.56	5
+NA	NA	NA	"860800"	17.86	7.51
+NA	NA	NA	"860817"	46.74	5.37
+NA	NA	NA	"860818"	66.98	-4.74
+NA	NA	NA	"860847"	49.6	3.82
+NA	NA	NA	"860858"	71.35	2.91
+NA	NA	NA	"860886"	79.95	-0.84
+NA	NA	NA	"860887"	40.03	-3.36
+NA	NA	NA	"860901"	52.32	-2.2
+NA	NA	NA	"860955"	43.73	6.47
+NA	NA	NA	"860995"	52.96	-0.27
+NA	NA	NA	"861023"	41.13	4.46
+NA	NA	NA	"861030"	61.22	2.95
+NA	NA	NA	"861065"	70	-4.41
+NA	NA	NA	"861091"	40	-0.1
+NA	NA	NA	"861093"	54.26	-4.82
+NA	NA	NA	"861114"	1.47	-2.1
+NA	NA	NA	"861290"	57.8	2.11
+NA	NA	NA	"861327"	18.01	6.42
+NA	NA	NA	"861341"	22.41	-1.79
+NA	NA	NA	"861367"	50.61	2.82
+NA	NA	NA	"861549"	17.89	6.54
+NA	NA	NA	"861604"	3.8	-0.57
+NA	NA	NA	"861648"	32.41	5.92
+NA	NA	NA	"861682"	3.55	7.73
+NA	NA	NA	"870030"	80.97	-2.6
+NA	NA	NA	"870081"	42.35	5.24
+NA	NA	NA	"870134"	64.22	-2.51
+NA	NA	NA	"870235"	75.45	4.06
+NA	NA	NA	"870289"	48	4.59
+NA	NA	NA	"870336"	1.34	0.43
+NA	NA	NA	"870398"	80.18	7.05
+NA	NA	NA	"870441"	55.56	6.8
+NA	NA	NA	"870466"	40.96	4.28
+NA	NA	NA	"870467"	80.55	1.71
+NA	NA	NA	"870516"	26.08	1.8
+NA	NA	NA	"870517"	59.11	-3.07
+NA	NA	NA	"870521"	34.41	-2.09
+NA	NA	NA	"870522"	67.82	4.86
+NA	NA	NA	"870540"	51.26	4.22
+NA	NA	NA	"870543"	14.18	5.44
+NA	NA	NA	"870547"	47.92	7.11
+NA	NA	NA	"870560"	72.7	-1.9
+NA	NA	NA	"870564"	73.82	-0.49
+NA	NA	NA	"870578"	36.45	2.35
+NA	NA	NA	"870594"	68.86	7.51
+NA	NA	NA	"870603"	46.79	6.68
+NA	NA	NA	"870626"	10.37	7.83
+NA	NA	NA	"870637"	34.25	-4.49
+NA	NA	NA	"870643"	23.11	8.12
+NA	NA	NA	"870671"	42.77	3.8
+NA	NA	NA	"870678"	45.29	6.98
+NA	NA	NA	"870696"	3.88	-0.59
+NA	NA	NA	"870728"	18.3	3.04
+NA	NA	NA	"870729"	83.25	6.36
+NA	NA	NA	"870732"	57.37	2.68
+NA	NA	NA	"870737"	29.93	5.2
+NA	NA	NA	"870774"	7.75	-0.36
+NA	NA	NA	"870782"	15.53	-2.51
+NA	NA	NA	"870797"	22.77	4.46
+NA	NA	NA	"870950"	71.35	6.5
+NA	NA	NA	"870975"	45.07	-0.45
+NA	NA	NA	"871001"	17.89	4.09
+NA	NA	NA	"871004"	2.31	-0.77
+NA	NA	NA	"871032"	69.86	2.88
+NA	NA	NA	"871045"	82.09	2.79
+NA	NA	NA	"871071"	67.17	-0.95
+NA	NA	NA	"871221"	72.81	4.5
+NA	NA	NA	"871225"	22.12	1.59
+NA	NA	NA	"871233"	86.15	7.98
+NA	NA	NA	"871255"	28.66	2.49
+NA	NA	NA	"871311"	13.02	3.07
+NA	NA	NA	"871335"	89.15	3.41
+NA	NA	NA	"871337"	71.78	-2.77
+NA	NA	NA	"880051"	11.47	-3.66
+NA	NA	NA	"880064"	50.96	1.69
+NA	NA	NA	"880090"	82.71	7.7
+NA	NA	NA	"880173"	53.59	-1.63
+NA	NA	NA	"880239"	29.7	4.04
+NA	NA	NA	"880598"	43.83	6.58
+NA	NA	NA	"880796"	29.39	-4.22
+NA	NA	NA	"881117"	15.88	8.17
+NA	NA	NA	"881353"	59.89	6.59
+NA	NA	NA	"890084"	6.71	6.92
+NA	NA	NA	"890089"	32.55	-3.01
+NA	NA	NA	"890145"	39.96	-3.35
+NA	NA	NA	"890169"	75.54	7.45
+NA	NA	NA	"890219"	84.43	-1.92
+NA	NA	NA	"890293"	64.61	0.03
+NA	NA	NA	"890491"	26.11	6.04
+NA	NA	NA	"890549"	24.95	5.65
+NA	NA	NA	"890878"	10.52	-4.1
+NA	NA	NA	"890916"	21.08	3.98
+NA	NA	NA	"890968"	79.46	5.9
+NA	NA	NA	"890971"	52.45	-1.96
+NA	NA	NA	"890985"	8.9	-1.15
+NA	NA	NA	"890986"	6.19	8
+NA	NA	NA	"891027"	61.6	2.7
+NA	NA	NA	"891295"	76.68	-2.14
+NA	NA	NA	"891493"	66.54	3.87
+NA	NA	NA	"891527"	67.76	2.5
+NA	NA	NA	"891534"	60.53	1.33
+NA	NA	NA	"891577"	49.9	-4.66
+NA	NA	NA	"891812"	47.27	4.54
+NA	NA	NA	"900045"	0.35	-1.43
+NA	NA	NA	"910015"	2.53	6.09
+NA	NA	NA	"910025"	34.83	-2.25
+NA	NA	NA	"910027"	18.63	-2.6
+NA	NA	NA	"910031"	9.21	1.14
+NA	NA	NA	"910032"	28.02	-0.49
+NA	NA	NA	"910037"	34.57	-0.62
+NA	NA	NA	"910042"	75.52	0.91
+NA	NA	NA	"910061"	31.81	7.5
+NA	NA	NA	"910064"	58.5	7.79
+NA	NA	NA	"910065"	36.04	5.25
+NA	NA	NA	"910068"	42.99	-2.4
+NA	NA	NA	"910071"	2.89	-3.94
+NA	NA	NA	"910092"	58.68	6.31
+NA	NA	NA	"910170"	36.25	0.12
+NA	NA	NA	"910229"	71.72	4
+NA	NA	NA	"910237"	13.21	5.77
+NA	NA	NA	"910260"	59.55	5.05
+NA	NA	NA	"910333"	23.06	7.39
+NA	NA	NA	"910364"	86.55	0.6
+NA	NA	NA	"910374"	42.87	2.54
+NA	NA	NA	"910406"	4.37	1.14
+NA	NA	NA	"910415"	73	-4.01
+NA	NA	NA	"920006"	16.34	-4.55
+NA	NA	NA	"920018"	32.25	-3.16
+NA	NA	NA	"920036"	61.69	4.41
+NA	NA	NA	"930004"	51.37	0.65
+NA	NA	NA	"930005"	13.52	7.62
+NA	NA	NA	"930006"	69.52	-2.54
+NA	NA	NA	"930011"	36.01	-3.41
+NA	NA	NA	"930013"	15.76	-0.09
+NA	NA	NA	"930015"	71.58	2.98
+NA	NA	NA	"930017"	87.71	2.91
+NA	NA	NA	"930018"	46.3	1.36
+NA	NA	NA	"930021"	56.47	4.53
+NA	NA	NA	"930022"	23.05	-1.47
+NA	NA	NA	"930023"	12.42	5.36
+NA	NA	NA	"930027"	32.12	0.84
+NA	NA	NA	"930030"	82.02	-1.56
+NA	NA	NA	"930031"	62.63	3.4
+NA	NA	NA	"930034"	80.2	4.06
+NA	NA	NA	"930035"	88.37	-3.76
+NA	NA	NA	"930038"	12.62	-1.73
+NA	NA	NA	"930042"	17.81	3.63
+NA	NA	NA	"930043"	89.07	-4.33
+NA	NA	NA	"930044"	37.86	5.54
+NA	NA	NA	"930045"	1.16	5.01
+NA	NA	NA	"930049"	24.12	7.61
+NA	NA	NA	"930050"	15.79	-4.68
+NA	NA	NA	"930053"	71.22	-2.75
+NA	NA	NA	"930055"	8.64	7.54
+NA	NA	NA	"930056"	18.67	3.34
+NA	NA	NA	"930058"	17.27	-1.2
+NA	NA	NA	"940008"	30.96	-4.28
+NA	NA	NA	"940025"	81.05	5.73
+NA	NA	NA	"940030"	37.78	1.1
+NA	NA	NA	"950017"	39.84	7.51
+NA	NA	NA	"950035"	24.94	0.9
+NA	NA	NA	"950036"	38.61	-2.17
+NA	NA	NA	"950037"	51.34	7.61
+NA	NA	NA	"950038"	35.88	-2.67
+NA	NA	NA	"950040"	27.25	4.72
+NA	NA	NA	"950079"	32.25	0.81
+NA	NA	NA	"950089"	6.45	-1.78
+NA	NA	NA	"950091"	10.65	4.11
+NA	NA	NA	"950096"	85.65	-0.45
+NA	NA	NA	"950153"	40.63	1.1
+NA	NA	NA	"950182"	41.8	-1.46
+NA	NA	NA	"950183"	28.09	-4.06
+NA	NA	NA	"950184"	56.89	7.24
+NA	NA	NA	"950218"	27.66	3.34
+NA	NA	NA	"950311"	70.72	3.81
--- /dev/null	Thu Jan 01 00:00:00 1970 +0000
+++ b/species_indicateur_fonctionnel.tabular	Thu Apr 02 03:35:29 2020 -0400
@@ -0,0 +1,442 @@
+"pk_species"	"ssi"	"ssi_old"	"ssi_2007"	"sti"	"sti_europe"	"thermal_niche_mean"	"thermal_niche_range"	"thermal_niche_max"	"thermal_niche_min"	"stri"	"exp_stri"	"trophic_vegetation"	"trophic_invertebrate"	"trophic_vertebrate"
+"_ANTVIR"	""	""	""	""	"15.6536"	""	""	""	""	""	""	""	""	""
+"_EMBRUS"	""	""	""	""	"6.33549"	""	""	""	""	""	""	""	""	""
+"ACCGEN"	"1.86088"	""	""	""	"11.8008"	""	""	""	""	"3"	"20.09"	""	""	""
+"ACCNIS"	"0.614413"	"0.787363"	"0.620015"	"13.8629"	"11.9163"	"12.3454"	"15.773"	"20.0974"	"4.3244"	"3"	"20.09"	0	0	100
+"ACRAGR"	""	""	""	""	"15.605"	""	""	""	""	""	""	""	""	""
+"ACRARU"	""	""	""	""	"13.8794"	""	""	""	""	""	""	""	""	""
+"ACRDUM"	""	""	""	""	"9.51237"	""	""	""	""	""	""	""	""	""
+"ACRMEL"	""	""	""	""	"16.574"	""	""	""	""	""	""	""	""	""
+"ACRPAL"	""	""	""	""	"12.3618"	""	""	""	""	""	""	""	""	""
+"ACRRIS"	"1.70476"	""	""	""	"12.2481"	""	""	""	""	"2"	"7.39"	""	""	""
+"ACRSCH"	"2.50428"	""	""	""	"11.3914"	""	""	""	""	"1.95"	"7.03"	""	""	""
+"ACRSCI"	"2.08314"	""	""	""	"13.1524"	""	""	""	""	"1.95"	"7.03"	""	""	""
+"ACTHYP"	""	""	""	""	"11.2048"	""	""	""	""	""	""	""	""	""
+"AEGCAU"	"0.585681"	"0.62316"	"0.438564"	"14.4881"	"12.6608"	"12.9783"	"13.3142"	"19.328"	"6.01376"	"1.95"	"7.03"	5	95	0
+"AEGFUN"	""	""	""	""	"9.10055"	""	""	""	""	""	""	""	""	""
+"AEGMON"	""	""	""	""	"16.1423"	""	""	""	""	""	""	""	""	""
+"AIXGAL"	""	""	""	""	"12.0189"	""	""	""	""	""	""	""	""	""
+"AIXSPO"	""	""	""	""	"12.3348"	""	""	""	""	""	""	""	""	""
+"ALAARV"	"1.18758"	"1.1554"	"0.921955"	"14.1497"	"12.1983"	"12.508"	"15.4477"	"19.7438"	"4.29613"	"1.25"	"3.49"	75	25	0
+"ALCATT"	"2.18545"	""	""	""	"13.5319"	""	""	""	""	"2.81"	"16.61"	""	""	""
+"ALCTOR"	""	""	""	""	"8.98323"	""	""	""	""	""	""	""	""	""
+"ALEBAR"	""	""	""	""	"17.9565"	""	""	""	""	""	""	""	""	""
+"ALECHU"	""	""	""	""	"16.2056"	""	""	""	""	""	""	""	""	""
+"ALEGRA"	""	""	""	""	"13.1661"	""	""	""	""	""	""	""	""	""
+"ALERUF"	"1.10584"	"1.0973"	"0.92039"	"16.0692"	"14.8075"	"15.2367"	"11.2723"	"20.5323"	"9.26"	"1.1"	"3"	90	10	0
+"ALLALL"	""	""	""	""	"-8.26474"	""	""	""	""	""	""	""	""	""
+"ALOAEG"	""	""	""	""	"12.3931"	""	""	""	""	""	""	""	""	""
+"ANAACU"	""	""	""	""	"8.52735"	""	""	""	""	""	""	""	""	""
+"ANACLY"	""	""	""	""	"11.7556"	""	""	""	""	""	""	""	""	""
+"ANACRE"	""	""	""	""	"10.0713"	""	""	""	""	""	""	""	""	""
+"ANAPEN"	""	""	""	""	"6.68293"	""	""	""	""	""	""	""	""	""
+"ANAPLA"	""	""	""	""	"11.8111"	""	""	""	""	""	""	""	""	""
+"ANAQUE"	""	""	""	""	"12.3896"	""	""	""	""	""	""	""	""	""
+"ANASTR"	""	""	""	""	"12.5159"	""	""	""	""	""	""	""	""	""
+"ANSALB"	""	""	""	""	"1.40206"	""	""	""	""	""	""	""	""	""
+"ANSANS"	""	""	""	""	"11.1956"	""	""	""	""	""	""	""	""	""
+"ANSBRA"	""	""	""	""	"3.35896"	""	""	""	""	""	""	""	""	""
+"ANSERY"	""	""	""	""	"2.03545"	""	""	""	""	""	""	""	""	""
+"ANSFAB"	""	""	""	""	"4.29454"	""	""	""	""	""	""	""	""	""
+"ANTCAM"	"2.42803"	"1.99574"	"1.50106"	"16.3834"	"14.429"	"15.7224"	"11.5149"	"21.4068"	"9.89193"	"1.95"	"7.03"	5	95	0
+"ANTCER"	""	""	""	""	"3.13445"	""	""	""	""	""	""	""	""	""
+"ANTHOD"	""	""	""	""	"4.92396"	""	""	""	""	""	""	""	""	""
+"ANTPRA"	"1.37755"	"1.37459"	"1.26191"	"11.8267"	"9.94877"	"9.85028"	"13.4452"	"15.2037"	"1.75849"	"1.75"	"5.75"	25	75	0
+"ANTSPI"	""	""	""	""	"11.6825"	""	""	""	""	""	""	""	""	""
+"ANTSPISPI"	""	""	""	""	"11.6825"	""	""	""	""	""	""	""	""	""
+"ANTTRI"	"0.729307"	"0.910273"	"0.705309"	"13.2523"	"11.2439"	"11.6459"	"13.9098"	"17.9549"	"4.04508"	"1.95"	"7.03"	5	95	0
+"APUAPU"	"1.27125"	"1.29827"	"1.24046"	"14.3837"	"12.447"	"13.2293"	"16.075"	"21.2854"	"5.21042"	"2"	"7.39"	0	100	0
+"APUCAF"	""	""	""	""	"19.268"	""	""	""	""	""	""	""	""	""
+"APUMEL"	""	""	""	""	"14.7488"	""	""	""	""	""	""	""	""	""
+"APUPAL"	""	""	""	""	"17.4132"	""	""	""	""	""	""	""	""	""
+"AQUCHR"	""	""	""	""	"10.7378"	""	""	""	""	""	""	""	""	""
+"AQUCLA"	""	""	""	""	"12.2126"	""	""	""	""	""	""	""	""	""
+"AQUPOM"	""	""	""	""	"12.6813"	""	""	""	""	""	""	""	""	""
+"ARDCIN"	""	""	""	""	"12.6944"	""	""	""	""	""	""	""	""	""
+"ARDPUR"	""	""	""	""	"15.246"	""	""	""	""	""	""	""	""	""
+"ARDRAL"	""	""	""	""	"15.9223"	""	""	""	""	""	""	""	""	""
+"AREINT"	""	""	""	""	"7.73594"	""	""	""	""	""	""	""	""	""
+"ASIFLA"	""	""	""	""	"9.62002"	""	""	""	""	""	""	""	""	""
+"ASIOTU"	""	""	""	""	"12.294"	""	""	""	""	""	""	""	""	""
+"ATHNOC"	""	""	""	""	"14.2083"	""	""	""	""	""	""	""	""	""
+"AYTFER"	""	""	""	""	"12.4454"	""	""	""	""	""	""	""	""	""
+"AYTFUL"	""	""	""	""	"10.1386"	""	""	""	""	""	""	""	""	""
+"AYTMAR"	""	""	""	""	"4.37113"	""	""	""	""	""	""	""	""	""
+"AYTNYR"	""	""	""	""	"14.3405"	""	""	""	""	""	""	""	""	""
+"BOMGAR"	""	""	""	""	"5.77321"	""	""	""	""	""	""	""	""	""
+"BONBON"	""	""	""	""	"9.7371"	""	""	""	""	""	""	""	""	""
+"BOTSTE"	""	""	""	""	"13.1076"	""	""	""	""	""	""	""	""	""
+"BRABER"	""	""	""	""	"-4.59769"	""	""	""	""	""	""	""	""	""
+"BRACAN"	""	""	""	""	"9.54893"	""	""	""	""	""	""	""	""	""
+"BRALEU"	""	""	""	""	"9.28419"	""	""	""	""	""	""	""	""	""
+"BUBBUB"	""	""	""	""	"11.8718"	""	""	""	""	""	""	""	""	""
+"BUBIBI"	""	""	""	""	"18.2107"	""	""	""	""	""	""	""	""	""
+"BUCCLA"	""	""	""	""	"8.47429"	""	""	""	""	""	""	""	""	""
+"BUCISL"	""	""	""	""	"3.04567"	""	""	""	""	""	""	""	""	""
+"BULBUL"	""	""	""	""	"17.7121"	""	""	""	""	""	""	""	""	""
+"BUROED"	"1.95056"	"1.89748"	"1.52193"	"17.4327"	"15.8668"	"18.5569"	"17.9197"	"29.1006"	"11.1809"	"1.95"	"7.03"	5	95	0
+"BUTBUT"	"0.574316"	"0.494943"	"0.585595"	"14.6525"	"12.6974"	"13.0152"	"13.1745"	"19.4801"	"6.30557"	"2.9"	"18.17"	0	10	90
+"BUTLAG"	""	""	""	""	"5.23134"	""	""	""	""	""	""	""	""	""
+"BUTRUF"	""	""	""	""	"16.2118"	""	""	""	""	""	""	""	""	""
+"CALALP"	""	""	""	""	"7.06638"	""	""	""	""	""	""	""	""	""
+"CALBRA"	""	""	""	""	"16.28"	""	""	""	""	""	""	""	""	""
+"CALCAL"	""	""	""	""	"14.2968"	""	""	""	""	""	""	""	""	""
+"CALDIO"	""	""	""	""	"18.5569"	""	""	""	""	""	""	""	""	""
+"CALLAP"	""	""	""	""	"4.06383"	""	""	""	""	""	""	""	""	""
+"CALMAR"	""	""	""	""	"3.87988"	""	""	""	""	""	""	""	""	""
+"CALMEL"	""	""	""	""	"-1.22119"	""	""	""	""	""	""	""	""	""
+"CALMIN"	""	""	""	""	"2.73302"	""	""	""	""	""	""	""	""	""
+"CALRUF"	""	""	""	""	"17.0539"	""	""	""	""	""	""	""	""	""
+"CALTEM"	""	""	""	""	"4.17153"	""	""	""	""	""	""	""	""	""
+"CAPEUR"	""	""	""	""	"13.1103"	""	""	""	""	""	""	""	""	""
+"CAPRUF"	""	""	""	""	"17.5621"	""	""	""	""	""	""	""	""	""
+"CARCAN"	"0.678321"	"0.69683"	"0.597376"	"15.0534"	"13.1604"	"14.2114"	"13.2644"	"21.4034"	"8.13908"	"1.05"	"2.86"	95	5	0
+"CARCAR"	"0.753282"	"0.704341"	"0.650258"	"15.3679"	"13.4542"	"14.6936"	"14.3588"	"22.9379"	"8.5791"	"1.05"	"2.86"	95	5	0
+"CARCHL"	"0.838069"	"0.657207"	"0.570617"	"15.1894"	"12.6006"	"13.8886"	"15.2923"	"21.5397"	"6.24732"	"1.05"	"2.86"	95	5	0
+"CARERY"	""	""	""	""	"10.3483"	""	""	""	""	""	""	""	""	""
+"CARFLA"	""	""	""	""	"8.19231"	""	""	""	""	""	""	""	""	""
+"CARHOR"	""	""	""	""	"3.08868"	""	""	""	""	""	""	""	""	""
+"CARRIS"	""	""	""	""	"6.94625"	""	""	""	""	""	""	""	""	""
+"CARSPI"	"2.62081"	""	""	""	"10.2425"	""	""	""	""	"1.03"	"2.8"	""	""	""
+"CEPGRY"	""	""	""	""	"7.45566"	""	""	""	""	""	""	""	""	""
+"CERBRA"	"0.612574"	"0.621996"	"0.544511"	"15.7002"	"13.8973"	"15.3616"	"12.1146"	"21.2164"	"9.10174"	"2"	"7.39"	0	100	0
+"CERFAM"	"1.95824"	"1.89"	"1.42419"	"13.0651"	"11.1195"	"11.7709"	"12.6035"	"17.7345"	"5.13102"	"1.95"	"7.03"	5	95	0
+"CERGAL"	""	""	""	""	"18.6085"	""	""	""	""	""	""	""	""	""
+"CETCET"	"1.84937"	"1.35808"	"1.14564"	"17.3463"	"15.9492"	"16.9112"	"14.7673"	"23.3435"	"8.57622"	"2"	"7.39"	0	100	0
+"CHAALE"	""	""	""	""	"16.3072"	""	""	""	""	""	""	""	""	""
+"CHAASI"	""	""	""	""	"16.2645"	""	""	""	""	""	""	""	""	""
+"CHADUB"	""	""	""	""	"12.7729"	""	""	""	""	""	""	""	""	""
+"CHAHIA"	""	""	""	""	"8.22146"	""	""	""	""	""	""	""	""	""
+"CHALES"	""	""	""	""	"14.6817"	""	""	""	""	""	""	""	""	""
+"CHAMOR"	""	""	""	""	"5.38502"	""	""	""	""	""	""	""	""	""
+"CHEDUP"	""	""	""	""	"14.9653"	""	""	""	""	""	""	""	""	""
+"CHEGRE"	""	""	""	""	"14.6349"	""	""	""	""	""	""	""	""	""
+"CHLHYB"	""	""	""	""	"14.8788"	""	""	""	""	""	""	""	""	""
+"CHLLEU"	""	""	""	""	"13.1741"	""	""	""	""	""	""	""	""	""
+"CHLNIG"	""	""	""	""	"13.0082"	""	""	""	""	""	""	""	""	""
+"CICCIC"	"2.91363"	""	""	""	"13.611"	""	""	""	""	"2.6"	"13.46"	""	""	""
+"CICNIG"	""	""	""	""	"13.1077"	""	""	""	""	""	""	""	""	""
+"CINCIN"	"2.72292"	""	""	""	"11.015"	""	""	""	""	"2"	"7.39"	""	""	""
+"CIRAER"	"2.2666"	"2.05704"	"2.38313"	"15.2728"	"13.2259"	"13.6722"	"15.1964"	"22.6326"	"7.43621"	"3"	"20.09"	0	0	100
+"CIRCYA"	"1.37981"	"1.25317"	"1.48217"	"12.7212"	"10.6284"	"11.063"	"13.2879"	"16.833"	"3.54511"	"3"	"20.09"	0	0	100
+"CIRGAL"	"1.60618"	""	""	""	"14.6544"	""	""	""	""	"3"	"20.09"	""	""	""
+"CIRMAC"	""	""	""	""	"13.8642"	""	""	""	""	""	""	""	""	""
+"CIRPYG"	"1.41354"	"1.68954"	"1.5083"	"15.7504"	"13.6904"	"14.3518"	"9.32976"	"19.6703"	"10.3405"	"2.6"	"13.46"	0	40	60
+"CISJUN"	"2.41649"	"2.14811"	"1.64227"	"18.1548"	"16.8491"	"19.0736"	"15.5653"	"27.854"	"12.2886"	"2"	"7.39"	0	100	0
+"CLAGLA"	"2.07065"	""	""	""	"16.706"	""	""	""	""	"2"	"7.39"	""	""	""
+"CLAHYE"	""	""	""	""	"3.38535"	""	""	""	""	""	""	""	""	""
+"COCCOC"	"1.30057"	"0.983755"	"0.857174"	"14.9707"	"12.9763"	"14.0176"	"10.9858"	"19.8149"	"8.8291"	"1.05"	"2.86"	95	5	0
+"COLLIV"	"2.04338"	"2.03723"	"2.15525"	"14.611"	"12.7922"	"15.5755"	"23.37"	"30.228"	"6.858"	"1.01"	"2.75"	99	1	0
+"COLOEN"	"0.884448"	"1.29082"	"0.951158"	"14.1809"	"12.4358"	"13.4029"	"11.2216"	"19.2938"	"8.07224"	"1.01"	"2.75"	99	1	0
+"COLPAL"	"0.343291"	"0.299951"	"0.210529"	"14.1544"	"12.2214"	"12.989"	"16.3147"	"21.5235"	"5.20879"	"1.01"	"2.75"	99	1	0
+"COLVIR"	""	""	""	""	"14.4899"	""	""	""	""	""	""	""	""	""
+"CORCOR"	"0.40942"	"0.281072"	"0.214543"	"14.0953"	"12.1294"	""	""	""	""	"1.51"	"4.53"	""	""	""
+"CORFRU"	"1.10376"	"0.845527"	"0.879635"	"14.7353"	"12.7341"	"13.4259"	"11.0666"	"18.7374"	"7.67086"	"1.63"	"5.1"	46	42	11
+"CORGAR"	"2.08737"	""	""	""	"14.817"	""	""	""	""	"2"	"7.39"	""	""	""
+"SURULU"	""	""	""	""	"5.79559"	""	""	""	""	""	""	""	""	""
+"CORMON"	"0.847356"	"0.959838"	"0.834487"	"14.8876"	"12.9582"	"13.4372"	"13.6661"	"20.2449"	"6.57877"	"1.11"	"3.03"	90	9	1
+"CORRAX"	"1.40905"	"1.22823"	"1.03099"	"14.0953"	"11.7378"	"12.3658"	"20.2476"	"22.6104"	"2.36277"	"1.75"	"5.75"	50	25	25
+"COTCOT"	"1.39988"	"1.52376"	"1.35456"	"15.5838"	"13.6003"	"14.693"	"13.7205"	"22.1066"	"8.3861"	"1.22"	"3.39"	78	22	0
+"CRECRE"	""	""	""	""	"11.9688"	""	""	""	""	""	""	""	""	""
+"CUCCAN"	"0.388081"	"0.43348"	"0.436097"	"14.1171"	"12.1394"	"12.714"	"16.1486"	"20.46"	"4.31148"	"2"	"7.39"	0	100	0
+"CYACYA"	""	""	""	""	"17.5572"	""	""	""	""	""	""	""	""	""
+"CYGCOL"	""	""	""	""	"0.740472"	""	""	""	""	""	""	""	""	""
+"CYGCYG"	""	""	""	""	"6.26509"	""	""	""	""	""	""	""	""	""
+"CYGOLO"	"2.56696"	""	""	""	"12.19"	""	""	""	""	"1"	"2.72"	""	""	""
+"DELURB"	"1.3038"	"1.26632"	"1.55545"	"14.3044"	"12.3471"	"13.0523"	"17.0008"	"21.4263"	"4.42548"	"2"	"7.39"	0	100	0
+"DENLEU"	""	""	""	""	"11.4359"	""	""	""	""	""	""	""	""	""
+"DENMAJ"	"0.635651"	"0.63788"	"0.579273"	"14.0998"	"12.1154"	"12.1895"	"15.2036"	"19.3768"	"4.17318"	"1.7"	"5.47"	30	70	0
+"DENMED"	"2.22312"	"1.92"	"1.79394"	"15.1839"	"13.2449"	"14.6267"	"10.278"	"19.7291"	"9.4511"	"1.7"	"5.47"	30	70	0
+"DENMIN"	"0.858045"	"0.913494"	"0.591457"	"13.5716"	"11.551"	"11.9554"	"14.8884"	"18.9171"	"4.02869"	"2"	"7.39"	0	100	0
+"DENSYR"	""	""	""	""	"14.1598"	""	""	""	""	""	""	""	""	""
+"DRYMAR"	"1.0734"	"1.23504"	"1.09912"	"13.0689"	"11.1194"	"11.3861"	"13.1613"	"17.5672"	"4.4059"	"2"	"7.39"	0	100	0
+"EGRALB"	""	""	""	""	"14.8916"	""	""	""	""	""	""	""	""	""
+"EGRGAR"	"2.57997"	""	""	""	"15.917"	""	""	""	""	"2.5"	"12.18"	""	""	""
+"ELACAE"	""	""	""	""	"17.6926"	""	""	""	""	""	""	""	""	""
+"EMBAUR"	""	""	""	""	"9.21227"	""	""	""	""	""	""	""	""	""
+"EMBCAE"	""	""	""	""	"17.9868"	""	""	""	""	""	""	""	""	""
+"EMBCIA"	"1.91018"	"1.47"	"0.670555"	"16.3343"	"14.4204"	"15.816"	"16.8576"	"22.7405"	"5.88289"	"1.3"	"3.67"	70	30	0
+"EMBCIR"	"0.714234"	"0.585545"	"0.473803"	"16.7448"	"15.0545"	"16.5473"	"11.8069"	"21.45"	"9.64315"	"1.3"	"3.67"	70	30	0
+"EMBCIT"	"0.681933"	"0.711271"	"0.577612"	"13.5041"	"11.5528"	"11.7548"	"12.8308"	"17.3722"	"4.54137"	"1.3"	"3.67"	70	30	0
+"EMBHOR"	"2.16648"	"1.32"	"0.991336"	"14.7907"	"12.7263"	"13.1475"	"12.7177"	"19.3929"	"6.67514"	"1.95"	"7.03"	5	95	0
+"EMBLEU"	""	""	""	""	"8.24743"	""	""	""	""	""	""	""	""	""
+"EMBMEL"	""	""	""	""	"16.6374"	""	""	""	""	""	""	""	""	""
+"EMBPUS"	""	""	""	""	"4.66467"	""	""	""	""	""	""	""	""	""
+"EMBSCH"	"2.50757"	""	""	""	"11.2704"	""	""	""	""	"1.3"	"3.67"	""	""	""
+"EREALP"	""	""	""	""	"7.89509"	""	""	""	""	""	""	""	""	""
+"ERIRUB"	"0.523052"	"0.48404"	"0.414872"	"13.9545"	"11.9984"	"12.2379"	"14.9169"	"19.5628"	"4.64583"	"1.83"	"6.23"	17	83	0
+"FALBIA"	""	""	""	""	"16.8611"	""	""	""	""	""	""	""	""	""
+"FALCHE"	""	""	""	""	"14.2762"	""	""	""	""	""	""	""	""	""
+"FALCOL"	""	""	""	""	"6.82328"	""	""	""	""	""	""	""	""	""
+"FALELE"	""	""	""	""	"18.7439"	""	""	""	""	""	""	""	""	""
+"FALNAU"	""	""	""	""	"16.7317"	""	""	""	""	""	""	""	""	""
+"FALPER"	"1.91272"	""	""	""	"12.6432"	""	""	""	""	"3"	"20.09"	""	""	""
+"FALRUS"	""	""	""	""	"3.7442"	""	""	""	""	""	""	""	""	""
+"FALSUB"	"1.25106"	"1.5"	"1.28034"	"14.6875"	"12.6788"	"13.3098"	"13.8093"	"20.0283"	"6.21897"	"2.25"	"9.49"	0	75	25
+"FALTIN"	"0.632997"	"0.680845"	"0.656079"	"14.4077"	"12.4264"	"13.7595"	"21.4584"	"25.6245"	"4.16607"	"2.85"	"17.29"	0	15	85
+"FALVES"	""	""	""	""	"14.2518"	""	""	""	""	""	""	""	""	""
+"FICALB"	""	""	""	""	"13.0604"	""	""	""	""	""	""	""	""	""
+"FICHYP"	"1.316"	""	""	""	"10.4275"	""	""	""	""	"2"	"7.39"	""	""	""
+"FICPAR"	""	""	""	""	"11.5986"	""	""	""	""	""	""	""	""	""
+"FRAARC"	""	""	""	""	"8.0917"	""	""	""	""	""	""	""	""	""
+"FRICOE"	"0.29307"	"0.271686"	"0.251446"	"14.2614"	"12.2952"	"13.0696"	"16.3341"	"21.132"	"4.79794"	"1.1"	"3"	90	10	0
+"FRIMON"	""	""	""	""	"7.03053"	""	""	""	""	""	""	""	""	""
+"FULATR"	""	""	""	""	"12.9625"	""	""	""	""	""	""	""	""	""
+"FULCRI"	""	""	""	""	"19.6963"	""	""	""	""	""	""	""	""	""
+"FULGLA"	""	""	""	""	"8.4431"	""	""	""	""	""	""	""	""	""
+"GALCHL"	""	""	""	""	"13.3437"	""	""	""	""	""	""	""	""	""
+"GALCRI"	"1.82879"	"0.443536"	"1.43798"	"16.4479"	"14.4982"	"17.7215"	"19.0139"	"29.4257"	"10.4118"	"1.55"	"4.71"	45	55	0
+"GALGAL"	""	""	""	""	"10.267"	""	""	""	""	""	""	""	""	""
+"GALMED"	""	""	""	""	"8.19334"	""	""	""	""	""	""	""	""	""
+"GALTHE"	""	""	""	""	"16.8013"	""	""	""	""	""	""	""	""	""
+"GARGLA"	"0.449625"	"0.699789"	"0.439798"	"14.4084"	"12.4668"	"12.9317"	"15.4567"	"20.6722"	"5.21551"	"1.72"	"5.58"	28	72	0
+"GAVADA"	""	""	""	""	"-4.90987"	""	""	""	""	""	""	""	""	""
+"GAVARC"	""	""	""	""	"6.82986"	""	""	""	""	""	""	""	""	""
+"GAVIMM"	""	""	""	""	"4.20971"	""	""	""	""	""	""	""	""	""
+"GAVSTE"	""	""	""	""	"6.05105"	""	""	""	""	""	""	""	""	""
+"GELNIL"	""	""	""	""	"17.043"	""	""	""	""	""	""	""	""	""
+"GLANOR"	""	""	""	""	"15.2277"	""	""	""	""	""	""	""	""	""
+"GLAPAS"	""	""	""	""	"8.63044"	""	""	""	""	""	""	""	""	""
+"GLAPRA"	""	""	""	""	"17.4814"	""	""	""	""	""	""	""	""	""
+"GRUGRU"	""	""	""	""	"9.50057"	""	""	""	""	""	""	""	""	""
+"GYPBAR"	""	""	""	""	"12.793"	""	""	""	""	""	""	""	""	""
+"GYPFUL"	""	""	""	""	"15.2044"	""	""	""	""	""	""	""	""	""
+"HAEOST"	""	""	""	""	"10.474"	""	""	""	""	""	""	""	""	""
+"HALALB"	""	""	""	""	"10.7599"	""	""	""	""	""	""	""	""	""
+"HIEFAS"	""	""	""	""	"16.8334"	""	""	""	""	""	""	""	""	""
+"HIEPEN"	""	""	""	""	"15.1247"	""	""	""	""	""	""	""	""	""
+"HIMHIM"	""	""	""	""	"16.2911"	""	""	""	""	""	""	""	""	""
+"HIPCAL"	""	""	""	""	"11.8382"	""	""	""	""	""	""	""	""	""
+"HIPICT"	"1.99649"	""	""	""	"11.3917"	""	""	""	""	"1.95"	"7.03"	""	""	""
+"HIPOLI"	""	""	""	""	"17.7628"	""	""	""	""	""	""	""	""	""
+"HIPPAL"	""	""	""	""	"16.7489"	""	""	""	""	""	""	""	""	""
+"HIPPOL"	"0.536869"	"0.7212"	"0.395575"	"16.4226"	"14.8356"	"16.1998"	"13.4147"	"21.5603"	"8.14565"	"1.95"	"7.03"	5	95	0
+"HIRDAU"	""	""	""	""	"16.6554"	""	""	""	""	""	""	""	""	""
+"HIRRUS"	"0.76372"	"1.14095"	"1.00694"	"14.3572"	"12.4305"	"13.7202"	"19.2028"	"24.3558"	"5.15301"	"2"	"7.39"	0	100	0
+"HISHIS"	""	""	""	""	"3.565"	""	""	""	""	""	""	""	""	""
+"HYDPEL"	""	""	""	""	"13.9625"	""	""	""	""	""	""	""	""	""
+"IXOMIN"	""	""	""	""	"14.2935"	""	""	""	""	""	""	""	""	""
+"JYNTOR"	"0.789751"	"1.31465"	"0.468726"	"13.9297"	"11.8813"	"12.5214"	"14.1635"	"19.1389"	"4.97541"	"2"	"7.39"	0	100	0
+"LAGLAG"	""	""	""	""	"6.73787"	""	""	""	""	""	""	""	""	""
+"LAGMUT"	""	""	""	""	"6.02468"	""	""	""	""	""	""	""	""	""
+"LANCOL"	"1.10226"	"1.23797"	"0.920833"	"14.6483"	"12.6239"	"13.4682"	"12.5961"	"19.7362"	"7.14011"	"2.15"	"8.58"	0	85	15
+"LANEXC"	""	""	""	""	"11.2044"	""	""	""	""	""	""	""	""	""
+"LANMIN"	""	""	""	""	"14.8453"	""	""	""	""	""	""	""	""	""
+"LANSEN"	"1.7427"	""	""	""	"15.8754"	""	""	""	""	"2.05"	"7.77"	""	""	""
+"LARARG"	""	""	""	""	"9.05834"	""	""	""	""	""	""	""	""	""
+"LARARGARG"	""	""	""	""	"9.05834"	""	""	""	""	""	""	""	""	""
+"LARAUD"	""	""	""	""	"18.6663"	""	""	""	""	""	""	""	""	""
+"LARCAN"	""	""	""	""	"8.57406"	""	""	""	""	""	""	""	""	""
+"LARFUS"	""	""	""	""	"8.91787"	""	""	""	""	""	""	""	""	""
+"LARGEN"	""	""	""	""	"17.4584"	""	""	""	""	""	""	""	""	""
+"LARGLA"	""	""	""	""	"-2.94903"	""	""	""	""	""	""	""	""	""
+"LARHYP"	""	""	""	""	"-0.69199"	""	""	""	""	""	""	""	""	""
+"LARMAR"	""	""	""	""	"8.36946"	""	""	""	""	""	""	""	""	""
+"LARMEL"	""	""	""	""	"13.9748"	""	""	""	""	""	""	""	""	""
+"LARMIC"	"1.7216"	""	""	""	"16.193"	""	""	""	""	"2.3"	"9.97"	""	""	""
+"LARMIN"	""	""	""	""	"9.35761"	""	""	""	""	""	""	""	""	""
+"LARRID"	""	""	""	""	"11.068"	""	""	""	""	""	""	""	""	""
+"LIMFAL"	""	""	""	""	"4.97336"	""	""	""	""	""	""	""	""	""
+"LIMLAP"	""	""	""	""	"3.25162"	""	""	""	""	""	""	""	""	""
+"LIMLIM"	""	""	""	""	"12.0468"	""	""	""	""	""	""	""	""	""
+"LOCFLU"	""	""	""	""	"12.3187"	""	""	""	""	""	""	""	""	""
+"LOCLAN"	""	""	""	""	"6.37862"	""	""	""	""	""	""	""	""	""
+"LOCLUS"	""	""	""	""	"13.5908"	""	""	""	""	""	""	""	""	""
+"LOCNAE"	"1.18018"	"1.24"	"0.92612"	"13.5811"	"11.7684"	""	""	""	""	"2"	"7.39"	""	""	""
+"LOXCUR"	"2.22013"	""	""	""	"10.4943"	""	""	""	""	"1.11"	"3.03"	""	""	""
+"LOXLEU"	""	""	""	""	"6.03978"	""	""	""	""	""	""	""	""	""
+"LOXPYT"	""	""	""	""	"7.21678"	""	""	""	""	""	""	""	""	""
+"LOXSCO"	""	""	""	""	"9.23721"	""	""	""	""	""	""	""	""	""
+"LULARB"	"0.910982"	"0.903077"	"0.623972"	"15.4347"	"13.472"	"14.5056"	"12.4622"	"21.2742"	"8.81198"	"1.5"	"4.48"	50	50	0
+"LUSLUS"	""	""	""	""	"11.8425"	""	""	""	""	""	""	""	""	""
+"LUSMEG"	"0.481346"	"0.470259"	"0.358723"	"16.2469"	"14.4949"	"16.0099"	"13.3447"	"22.2074"	"8.86272"	"2"	"7.39"	0	100	0
+"LUSSVE"	"3.01919"	""	""	""	"10.1598"	""	""	""	""	"2"	"7.39"	""	""	""
+"LYMMIN"	""	""	""	""	"5.82881"	""	""	""	""	""	""	""	""	""
+"MARANG"	""	""	""	""	"18.8024"	""	""	""	""	""	""	""	""	""
+"MELCAL"	""	""	""	""	"16.1242"	""	""	""	""	""	""	""	""	""
+"MELFUS"	""	""	""	""	"4.81336"	""	""	""	""	""	""	""	""	""
+"MELNIG"	""	""	""	""	"4.22591"	""	""	""	""	""	""	""	""	""
+"MERALB"	""	""	""	""	"5.48342"	""	""	""	""	""	""	""	""	""
+"MERAPI"	"1.60825"	"0.861843"	"1.02448"	"17.3289"	"15.3796"	"16.4095"	"14.3269"	"24.0378"	"9.71084"	"2"	"7.39"	0	100	0
+"MERMER"	""	""	""	""	"7.91186"	""	""	""	""	""	""	""	""	""
+"MERPER"	""	""	""	""	"14.7569"	""	""	""	""	""	""	""	""	""
+"MERSER"	""	""	""	""	"7.37249"	""	""	""	""	""	""	""	""	""
+"MILCAL"	"1.21116"	"1.46435"	"1.04335"	"16.039"	"14.2314"	""	""	""	""	"1.28"	"3.6"	""	""	""
+"MILMIG"	"0.789268"	"0.753045"	"0.840926"	"15.5972"	"13.4666"	"13.9509"	"14.8916"	"21.7092"	"6.81755"	"2.83"	"16.95"	0	17	83
+"MILMIL"	"1.31651"	"1.34374"	"1.41433"	"15.342"	"13.544"	""	""	""	""	"2.85"	"17.29"	""	""	""
+"MONNIV"	""	""	""	""	"9.80504"	""	""	""	""	""	""	""	""	""
+"MONSAX"	""	""	""	""	"13.7288"	""	""	""	""	""	""	""	""	""
+"MONSOL"	""	""	""	""	"16.3664"	""	""	""	""	""	""	""	""	""
+"MOTALB"	"0.717506"	"0.693271"	"0.635722"	"13.9073"	"11.9859"	"11.8371"	"18.4186"	"20.056"	"1.63743"	"2"	"7.39"	0	100	0
+"MOTCIN"	"1.60406"	""	""	""	"12.9122"	""	""	""	""	"2"	"7.39"	""	""	""
+"MOTCIT"	""	""	""	""	"12.5406"	""	""	""	""	""	""	""	""	""
+"MOTFLA"	"1.86497"	"2.09124"	"1.6649"	"14.2181"	"12.137"	"12.6236"	"17.551"	"21.4981"	"3.94717"	"2"	"7.39"	0	100	0
+"MUSSTR"	"0.875145"	"0.967366"	"0.649096"	"14.1296"	"12.1492"	"12.6632"	"16.4036"	"20.7408"	"4.33717"	"2"	"7.39"	0	100	0
+"NEOPER"	""	""	""	""	"15.3774"	""	""	""	""	""	""	""	""	""
+"NETRUF"	""	""	""	""	"14.5833"	""	""	""	""	""	""	""	""	""
+"NUCCAR"	""	""	""	""	"10.7296"	""	""	""	""	""	""	""	""	""
+"NUMARQ"	"1.93931"	""	""	""	"10.0493"	""	""	""	""	"2"	"7.39"	""	""	""
+"NUMPHA"	"2.19265"	""	""	""	"5.88832"	""	""	""	""	"2"	"7.39"	""	""	""
+"NYCNYC"	""	""	""	""	"15.1905"	""	""	""	""	""	""	""	""	""
+"NYCSCA"	""	""	""	""	"2.91235"	""	""	""	""	""	""	""	""	""
+"OCECAS"	""	""	""	""	"17.4696"	""	""	""	""	""	""	""	""	""
+"OCELEU"	""	""	""	""	"8.41565"	""	""	""	""	""	""	""	""	""
+"OENHIS"	""	""	""	""	"16.6059"	""	""	""	""	""	""	""	""	""
+"OENISA"	""	""	""	""	"15.5466"	""	""	""	""	""	""	""	""	""
+"OENLEU"	""	""	""	""	"17.0871"	""	""	""	""	""	""	""	""	""
+"OENOEN"	"1.88809"	"1.70359"	"1.28301"	"13.5562"	"11.6202"	"11.5893"	"18.5619"	"19.8588"	"1.29683"	"1.95"	"7.03"	5	95	0
+"OENPLE"	""	""	""	""	"15.2638"	""	""	""	""	""	""	""	""	""
+"ORIORI"	"0.48111"	"0.473188"	"0.459814"	"15.5236"	"13.4707"	"14.4162"	"11.8073"	"20.5141"	"8.70674"	"1.95"	"7.03"	5	95	0
+"OTITAR"	""	""	""	""	"15.6407"	""	""	""	""	""	""	""	""	""
+"OTUSCO"	""	""	""	""	"15.4051"	""	""	""	""	""	""	""	""	""
+"OXYJAM"	""	""	""	""	"11.3382"	""	""	""	""	""	""	""	""	""
+"OXYLEU"	""	""	""	""	"17.8705"	""	""	""	""	""	""	""	""	""
+"PAGEBU"	""	""	""	""	"-8.95161"	""	""	""	""	""	""	""	""	""
+"PANBIA"	""	""	""	""	"13.878"	""	""	""	""	""	""	""	""	""
+"PANHAL"	""	""	""	""	"8.91938"	""	""	""	""	""	""	""	""	""
+"PARATE"	"1.56738"	"1.38635"	"0.976722"	"13.7258"	"11.9046"	"12.3275"	"14.2139"	"19.8551"	"5.64115"	"1.6"	"4.95"	40	60	0
+"PARCAE"	"0.363874"	"0.350865"	"0.300248"	"14.6174"	"12.7367"	"13.8151"	"14.4744"	"20.8357"	"6.36133"	"1.8"	"6.05"	20	80	0
+"PARCIN"	""	""	""	""	"4.4728"	""	""	""	""	""	""	""	""	""
+"PARCRI"	"1.54348"	"1.61674"	"1.27495"	"13.6245"	"11.7118"	"12.1938"	"11.9518"	"17.9174"	"5.96556"	"1.6"	"4.95"	40	60	0
+"PARCYA"	""	""	""	""	"11.7754"	""	""	""	""	""	""	""	""	""
+"PARLUG"	""	""	""	""	"15.1051"	""	""	""	""	""	""	""	""	""
+"PARMAJ"	"0.279454"	"0.294945"	"0.228392"	"14.3054"	"12.3437"	"12.8921"	"16.3441"	"20.8579"	"4.51377"	"1.85"	"6.36"	15	85	0
+"PARMON"	"1.42374"	"1.39209"	"0.807668"	"12.2559"	"10.1958"	"10.7927"	"12.4771"	"15.9845"	"3.50745"	"1.6"	"4.95"	40	60	0
+"PARPAL"	"1.07803"	"0.987562"	"0.784673"	"14.21"	"12.3251"	"13.3596"	"11.6305"	"17.9866"	"6.35607"	"1.7"	"5.47"	30	70	0
+"PASDOM"	"1.2793"	"1.26364"	"1.10447"	"14.1404"	"12.2628"	"13.8934"	"24.0132"	"27.7104"	"3.69728"	"1.2"	"3.32"	80	20	0
+"PASHIS"	""	""	""	""	"17.062"	""	""	""	""	""	""	""	""	""
+"PASMON"	"1.07451"	"1.25134"	"0.91032"	"15.0374"	"13.0709"	"12.8182"	"15.622"	"19.4418"	"3.81977"	"1.15"	"3.16"	85	15	0
+"PELCRI"	""	""	""	""	"15.2608"	""	""	""	""	""	""	""	""	""
+"PELONO"	""	""	""	""	"14.6745"	""	""	""	""	""	""	""	""	""
+"PERAPI"	"1.22689"	""	""	""	"11.9608"	""	""	""	""	"2"	"7.39"	""	""	""
+"PERINF"	""	""	""	""	"5.7726"	""	""	""	""	""	""	""	""	""
+"PERPER"	"2.2038"	"2.10562"	"1.11597"	"14.8069"	"12.8464"	"13.3899"	"10.6253"	"18.8805"	"8.25517"	"1.1"	"3"	90	10	0
+"PETPET"	"2.43754"	""	""	""	"15.8837"	""	""	""	""	"1.22"	"3.39"	""	""	""
+"PHAARI"	""	""	""	""	"12.5428"	""	""	""	""	""	""	""	""	""
+"PHACAR"	""	""	""	""	"12.4695"	""	""	""	""	""	""	""	""	""
+"PHACOL"	"0.603798"	"0.868791"	"0.532474"	"14.5849"	"12.865"	"14.1541"	"10.8734"	"19.3016"	"8.42817"	"1.25"	"3.49"	75	25	0
+"PHAFUL"	""	""	""	""	"4.15042"	""	""	""	""	""	""	""	""	""
+"PHALOB"	""	""	""	""	"4.7092"	""	""	""	""	""	""	""	""	""
+"PHAPYG"	""	""	""	""	"15.9922"	""	""	""	""	""	""	""	""	""
+"PHIPUG"	""	""	""	""	"7.9733"	""	""	""	""	""	""	""	""	""
+"PHOOCH"	"1.06392"	"1.11689"	"0.958918"	"15.1858"	"13.2394"	"14.4645"	"12.9299"	"20.7704"	"7.84044"	"1.85"	"6.36"	15	85	0
+"PHOPHO"	"0.756574"	"0.970977"	"0.690626"	"13.2935"	"11.3098"	"11.7703"	"15.1255"	"18.89"	"3.76445"	"1.93"	"6.89"	7	93	0
+"PHORUB"	""	""	""	""	"19.1058"	""	""	""	""	""	""	""	""	""
+"PHYBON"	"0.961767"	"0.858597"	"0.629748"	"15.7488"	"13.8609"	"15.5607"	"15.7586"	"21.5934"	"5.83487"	"2"	"7.39"	0	100	0
+"PHYBOR"	""	""	""	""	"5.47238"	""	""	""	""	""	""	""	""	""
+"PHYCOL"	"0.473271"	"0.460005"	"0.394842"	"13.8845"	"11.9466"	"11.5805"	"14.0988"	"17.757"	"3.65817"	"1.95"	"7.03"	5	95	0
+"PHYDES"	""	""	""	""	"9.76171"	""	""	""	""	""	""	""	""	""
+"PHYINO"	""	""	""	""	"3.97172"	""	""	""	""	""	""	""	""	""
+"PHYSIB"	"1.82163"	"1.71953"	"1.32234"	"13.3549"	"11.3756"	"12.4653"	"10.8992"	"17.1979"	"6.29872"	"1.95"	"7.03"	5	95	0
+"PHYTRO"	"1.12831"	"1.11753"	"0.697834"	"12.452"	"10.4597"	""	""	""	""	"1.95"	"7.03"	""	""	""
+"PICCAN"	"2.21313"	""	""	""	"12.0606"	""	""	""	""	"2"	"7.39"	""	""	""
+"PICPIC"	"0.72715"	"0.702208"	"0.629173"	"14.1716"	"12.1558"	"12.6757"	"18.8408"	"22.5157"	"3.67492"	"1.51"	"4.53"	50	49	1
+"PICTRI"	""	""	""	""	"7.98197"	""	""	""	""	""	""	""	""	""
+"PICVIR"	"0.335355"	"0.384167"	"0.325771"	"14.7495"	"12.9414"	"13.7777"	"13.0868"	"19.5996"	"6.51277"	"2"	"7.39"	0	100	0
+"PINENU"	""	""	""	""	"5.00735"	""	""	""	""	""	""	""	""	""
+"PLALEU"	""	""	""	""	"15.2992"	""	""	""	""	""	""	""	""	""
+"PLEFAL"	""	""	""	""	"16.1132"	""	""	""	""	""	""	""	""	""
+"PLENIV"	""	""	""	""	"4.04482"	""	""	""	""	""	""	""	""	""
+"PLUAPR"	""	""	""	""	"7.00315"	""	""	""	""	""	""	""	""	""
+"PLUSQU"	""	""	""	""	"1.01043"	""	""	""	""	""	""	""	""	""
+"PODAUR"	""	""	""	""	"8.29965"	""	""	""	""	""	""	""	""	""
+"PODCRI"	""	""	""	""	"12.6861"	""	""	""	""	""	""	""	""	""
+"PODGRI"	""	""	""	""	"11.9387"	""	""	""	""	""	""	""	""	""
+"PODNIG"	""	""	""	""	"13.3391"	""	""	""	""	""	""	""	""	""
+"POLSTE"	""	""	""	""	"0.96746"	""	""	""	""	""	""	""	""	""
+"PORPAR"	""	""	""	""	"13.5009"	""	""	""	""	""	""	""	""	""
+"PORPOR"	""	""	""	""	"12.4065"	""	""	""	""	""	""	""	""	""
+"PORPUS"	""	""	""	""	"15.3497"	""	""	""	""	""	""	""	""	""
+"PORRIO"	""	""	""	""	"18.071"	""	""	""	""	""	""	""	""	""
+"PRUCOL"	""	""	""	""	"11.496"	""	""	""	""	""	""	""	""	""
+"PRUMOD"	"0.421095"	"0.495331"	"0.287379"	"12.8065"	"10.9083"	"10.9918"	"13.9506"	"17.5781"	"3.62745"	"1.5"	"4.48"	50	50	0
+"PSIKRA"	""	""	""	""	"13.7106"	""	""	""	""	""	""	""	""	""
+"PTEALC"	""	""	""	""	"17.2732"	""	""	""	""	""	""	""	""	""
+"PTEORI"	""	""	""	""	"16.8935"	""	""	""	""	""	""	""	""	""
+"PTYRUP"	"1.65226"	""	""	""	"14.4734"	""	""	""	""	"2"	"7.39"	""	""	""
+"PUFASS"	""	""	""	""	"17.4834"	""	""	""	""	""	""	""	""	""
+"PYRGRA"	""	""	""	""	"11.3931"	""	""	""	""	""	""	""	""	""
+"PYRPYR"	"0.979659"	"1.0525"	"0.889121"	"12.6644"	"10.7563"	""	""	""	""	"1.1"	"3"	""	""	""
+"PYRRAX"	""	""	""	""	"14.3291"	""	""	""	""	""	""	""	""	""
+"RALAQU"	""	""	""	""	"13.3215"	""	""	""	""	""	""	""	""	""
+"RECAVO"	""	""	""	""	"14.5831"	""	""	""	""	""	""	""	""	""
+"REGIGN"	"1.13798"	"1.08052"	"0.819508"	"15.0695"	"13.1999"	"14.5515"	"12.7657"	"20.6917"	"7.92593"	"2"	"7.39"	0	100	0
+"REGREG"	"1.66634"	"1.45985"	"1.34067"	"12.6939"	"10.8075"	"11.1916"	"12.4064"	"17.0259"	"4.61946"	"2"	"7.39"	0	100	0
+"REMPEN"	""	""	""	""	"13.7399"	""	""	""	""	""	""	""	""	""
+"RHOGIT"	""	""	""	""	"18.3578"	""	""	""	""	""	""	""	""	""
+"RIPRIP"	"2.08732"	""	""	""	"11.9551"	""	""	""	""	"2"	"7.39"	""	""	""
+"RISTRI"	""	""	""	""	"7.38737"	""	""	""	""	""	""	""	""	""
+"SAXRUB"	"1.5989"	"1.46251"	"1.00506"	"13.3062"	"11.299"	"11.6614"	"13.6775"	"17.8335"	"4.15606"	"2"	"7.39"	0	100	0
+"SAXTOR"	"0.804"	"0.775838"	"0.688668"	"15.772"	"13.9903"	"15.2056"	"13.2555"	"21.0812"	"7.82576"	"2"	"7.39"	0	100	0
+"SCORUS"	""	""	""	""	"10.6011"	""	""	""	""	""	""	""	""	""
+"SERCIT"	""	""	""	""	"11.3532"	""	""	""	""	""	""	""	""	""
+"SERSER"	"0.89938"	"0.77666"	"0.681981"	"15.8333"	"13.8814"	"15.5488"	"13.0175"	"22.158"	"9.14048"	"1"	"2.72"	100	0	0
+"SITEUR"	"0.958605"	"0.922888"	"0.778929"	"14.7519"	"12.7947"	"13.0224"	"13.2114"	"19.6074"	"6.39604"	"1.63"	"5.1"	37	63	0
+"SITNEU"	""	""	""	""	"16.4086"	""	""	""	""	""	""	""	""	""
+"SITWHI"	""	""	""	""	"15.8652"	""	""	""	""	""	""	""	""	""
+"SOMMOL"	""	""	""	""	"8.16883"	""	""	""	""	""	""	""	""	""
+"STEALB"	""	""	""	""	"13.6555"	""	""	""	""	""	""	""	""	""
+"STEBEN"	""	""	""	""	"18.1615"	""	""	""	""	""	""	""	""	""
+"STECAS"	""	""	""	""	"10.2516"	""	""	""	""	""	""	""	""	""
+"STECUS"	""	""	""	""	"5.96359"	""	""	""	""	""	""	""	""	""
+"STEDOU"	""	""	""	""	"12.7248"	""	""	""	""	""	""	""	""	""
+"STEFUS"	""	""	""	""	"17.3272"	""	""	""	""	""	""	""	""	""
+"STEHIR"	""	""	""	""	"11.4396"	""	""	""	""	""	""	""	""	""
+"STELON"	""	""	""	""	"3.57231"	""	""	""	""	""	""	""	""	""
+"STEPAR"	""	""	""	""	"6.7215"	""	""	""	""	""	""	""	""	""
+"STEPOM"	""	""	""	""	"0.525384"	""	""	""	""	""	""	""	""	""
+"STESAN"	""	""	""	""	"12.3093"	""	""	""	""	""	""	""	""	""
+"STESKU"	""	""	""	""	"5.0753"	""	""	""	""	""	""	""	""	""
+"STRALU"	""	""	""	""	"12.8739"	""	""	""	""	""	""	""	""	""
+"STRDEC"	"1.04334"	"0.991969"	"0.960984"	"14.7911"	"12.9162"	"14.6564"	"19.7723"	"26.9157"	"7.14336"	"1"	"2.72"	100	0	0
+"STRNEB"	""	""	""	""	"6.85586"	""	""	""	""	""	""	""	""	""
+"STRSEN"	""	""	""	""	"14.8563"	""	""	""	""	""	""	""	""	""
+"STRTUR"	"0.451923"	"0.400338"	"0.379551"	"15.7236"	"13.7662"	"15.5491"	"21.8016"	"29.5579"	"7.75632"	"1"	"2.72"	100	0	0
+"STRURA"	""	""	""	""	"9.2298"	""	""	""	""	""	""	""	""	""
+"STUROS"	""	""	""	""	"15.8791"	""	""	""	""	""	""	""	""	""
+"STUUNI"	""	""	""	""	"16.5557"	""	""	""	""	""	""	""	""	""
+"STUVUL"	"0.678736"	"0.570593"	"0.530414"	"13.7636"	"11.8028"	"12.3572"	"14.9439"	"19.2662"	"4.32237"	"1.5"	"4.48"	50	50	0
+"SULBAS"	""	""	""	""	"8.73326"	""	""	""	""	""	""	""	""	""
+"SYLATR"	"0.291053"	"0.316278"	"0.235556"	"14.5232"	"12.6192"	"13.1921"	"13.8615"	"20.0016"	"6.14015"	"1.6"	"4.95"	40	60	0
+"SYLBOR"	"0.679919"	"0.693892"	"0.449187"	"13.299"	"11.3163"	"12.0225"	"13.1888"	"17.7172"	"4.52839"	"1.6"	"4.95"	40	60	0
+"SYLCAN"	"1.77527"	"1.33114"	"1.24176"	"18.0076"	"16.4215"	"17.3734"	"12.0385"	"22.1208"	"10.0823"	"1.8"	"6.05"	20	80	0
+"SYLCOM"	"0.624932"	"0.653973"	"0.556872"	"14.5746"	"12.6536"	"13.3891"	"13.5529"	"20.3339"	"6.78104"	"1.6"	"4.95"	40	60	0
+"SYLCON"	""	""	""	""	"16.9718"	""	""	""	""	""	""	""	""	""
+"SYLCUR"	"0.91895"	"1.01449"	"0.773661"	"13.6456"	"11.6399"	"12.3091"	"13.3496"	"18.5634"	"5.21378"	"1.8"	"6.05"	20	80	0
+"SYLHOR"	"2.04495"	"1.35"	"0.966924"	"17.7918"	"16.2234"	"17.5009"	"12.0605"	"21.8019"	"9.74135"	"1.7"	"5.47"	30	70	0
+"SYLMEL"	"1.61695"	"0.755948"	"0.596166"	"18.4332"	"16.9658"	"18.3292"	"12.0397"	"23.0259"	"10.9863"	"1.7"	"5.47"	30	70	0
+"SYLNIS"	""	""	""	""	"12.8776"	""	""	""	""	""	""	""	""	""
+"SYLRUE"	""	""	""	""	"19.113"	""	""	""	""	""	""	""	""	""
+"SYLSAR"	""	""	""	""	"17.5973"	""	""	""	""	""	""	""	""	""
+"SYLUND"	"2.66103"	"2.06494"	"1.46052"	"17.1553"	"15.8211"	"16.7325"	"10.1522"	"21.0617"	"10.9095"	"1.9"	"6.69"	10	90	0
+"SYRREE"	""	""	""	""	"13.4773"	""	""	""	""	""	""	""	""	""
+"TACRUF"	""	""	""	""	"13.4634"	""	""	""	""	""	""	""	""	""
+"TADFER"	""	""	""	""	"15.5742"	""	""	""	""	""	""	""	""	""
+"TADTAD"	""	""	""	""	"12.0434"	""	""	""	""	""	""	""	""	""
+"TARCYA"	""	""	""	""	"6.56761"	""	""	""	""	""	""	""	""	""
+"TETRAX"	""	""	""	""	"16.1633"	""	""	""	""	""	""	""	""	""
+"TETRIX"	""	""	""	""	"8.99648"	""	""	""	""	""	""	""	""	""
+"TETURO"	""	""	""	""	"8.73708"	""	""	""	""	""	""	""	""	""
+"TICMUR"	""	""	""	""	"11.0821"	""	""	""	""	""	""	""	""	""
+"TRICIN"	""	""	""	""	"10.598"	""	""	""	""	""	""	""	""	""
+"TRIERY"	""	""	""	""	"4.77171"	""	""	""	""	""	""	""	""	""
+"TRIGLA"	""	""	""	""	"7.67062"	""	""	""	""	""	""	""	""	""
+"TRINEB"	""	""	""	""	"6.45053"	""	""	""	""	""	""	""	""	""
+"TRIOCH"	""	""	""	""	"9.87852"	""	""	""	""	""	""	""	""	""
+"TRISTA"	""	""	""	""	"13.0028"	""	""	""	""	""	""	""	""	""
+"TRITOT"	""	""	""	""	"11.0359"	""	""	""	""	""	""	""	""	""
+"TROTRO"	"0.430257"	"0.371592"	"0.34744"	"14.0432"	"12.2368"	"12.9074"	"15.9244"	"20.6657"	"4.74128"	"2"	"7.39"	0	100	0
+"TURILI"	""	""	""	""	"8.25096"	""	""	""	""	""	""	""	""	""
+"TURMER"	"0.237414"	"0.233557"	"0.193482"	"14.4463"	"12.5843"	"13.7146"	"16.3924"	"21.7949"	"5.40248"	"1.6"	"4.95"	40	60	0
+"TURPHI"	"0.45115"	"0.401706"	"0.375644"	"13.3325"	"11.3957"	"11.6012"	"14.214"	"17.9786"	"3.76458"	"1.57"	"4.81"	43	57	0
+"TURPIL"	"1.49239"	"1.38586"	"0.892988"	"12.1874"	"10.0287"	"10.5189"	"13.5309"	"16.2458"	"2.71486"	"1.6"	"4.95"	40	60	0
+"TURRUF"	""	""	""	""	"4.03574"	""	""	""	""	""	""	""	""	""
+"TURSYL"	""	""	""	""	"20.7412"	""	""	""	""	""	""	""	""	""
+"TURTOR"	"2.24162"	""	""	""	"9.03076"	""	""	""	""	"1.7"	"5.47"	""	""	""
+"TURVIS"	"0.529272"	"0.517882"	"0.506435"	"13.8021"	"11.9147"	"12.4433"	"14.7843"	"19.8083"	"5.02401"	"1.55"	"4.71"	45	55	0
+"TYTALB"	""	""	""	""	"13.9906"	""	""	""	""	""	""	""	""	""
+"UPUEPO"	"0.544659"	"0.606751"	"0.386247"	"16.2542"	"14.1794"	"15.9169"	"15.3301"	"24.5791"	"9.24903"	"2"	"7.39"	0	100	0
+"URIAAL"	""	""	""	""	"9.58898"	""	""	""	""	""	""	""	""	""
+"URILOM"	""	""	""	""	"1.03554"	""	""	""	""	""	""	""	""	""
+"VANVAN"	"2.20961"	"2.22758"	"2.01969"	"13.5008"	"11.5326"	"11.9405"	"14.1509"	"18.5567"	"4.40578"	"1.9"	"6.69"	10	90	0
+"XENCIN"	""	""	""	""	"10.598"	""	""	""	""	""	""	""	""	""
--- /dev/null	Thu Jan 01 00:00:00 1970 +0000
+++ b/stoceps_macros.xml	Thu Apr 02 03:35:29 2020 -0400
@@ -0,0 +1,73 @@
+<macros>
+    <token name="@VERSION@">0.0.1</token>
+    <xml name="reshape_requirements">
+        <requirements>
+            <requirement type="package" version="0.8.8">r-reshape</requirement>
+            <requirement type="package" version="1.12.0">r-data.table</requirement>
+        </requirements>    
+    </xml>
+    <xml name="reshape2_requirements">
+        <requirements>
+            <requirement type="package" version="1.4.3">r-reshape2</requirement>
+        </requirements>    
+    </xml>
+    <xml name="mainglm_requirements">
+        <requirements>
+            <requirement type="package" version="3.0.0">r-ggplot2</requirement>
+            <requirement type="package" version="0.3_2">r-speedglm</requirement>
+            <requirement type="package" version="1.10_1">r-arm</requirement>
+            <requirement type="package" version="1.12.0">r-data.table</requirement>
+            <requirement type="package" version="1.4.3">r-reshape2</requirement>
+        </requirements>
+    </xml>
+    <xml name="temp_indic_requirements">
+        <requirements>
+            <requirement type="package" version="1.3_15">r-rodbc</requirement>
+            <requirement type="package" version="0.8.8">r-reshape</requirement>
+            <requirement type="package" version="1.12.0">r-data.table</requirement>
+            <requirement type="package" version="1.4_3">r-rgdal</requirement>
+            <requirement type="package" version="1.7.4">r-lubridate</requirement>
+            <requirement type="package" version="4.6_2">r-doby</requirement>
+            <requirement type="package" version="1.10_1">r-arm</requirement>
+            <requirement type="package" version="3.1.0">r-ggplot2</requirement>
+            <requirement type="package" version="1.0.0">r-scales</requirement>
+            <requirement type="package" version="1.8_24">r-mgcv</requirement>
+            <requirement type="package" version="1.8.4">r-plyr</requirement>
+            <requirement type="package" version="0.3_2">r-speedglm</requirement>
+            <requirement type="package" version="3.1_0">r-lmertest</requirement>
+            <requirement type="package" version="0.2.3">r-glmmtmb</requirement>
+        </requirements>
+    </xml>
+    <xml name="stoceps_input_filtered">
+        <param name="input" type="data" format="tabular" label="Stoc filtered input" help="Input Stoc count file, shaped and filtered with the 'preprocess population data' and 'filter species' tools." />
+    </xml>
+    <xml name="stoceps_advanced_params_select">
+        <param name="advanced" type="select" label="Specify advanced parameters">
+            <option value="simple" selected="true">No, use program defaults.</option>
+            <option value="advanced">Yes, see full parameter list.</option>
+        </param>        
+        <when value="simple">
+        </when>        
+    </xml>
+    <xml name="stoceps_compute_ic">
+        <param name="compute_ic" type="boolean" truevalue="TRUE" falsevalue="FALSE" checked="yes" label="Compute confidence intervals"/>
+    </xml>
+    <xml name="stoceps_filter_glmmtmb">
+        <filter> settings['advanced'] == 'advanced'</filter>
+        <filter> settings['method'] == 'glmmtmb'</filter>
+    </xml>
+    <xml name="stoceps_filter_gam">
+        <filter> settings['method'] == 'gam'</filter>
+    </xml>
+    <xml name="stoceps_bibref">
+        <citations>
+            <citation type="bibtex">
+	    @unpublished{stocepsromain,
+	    title={Vigie-Nature STOC unpublished scripts},
+            author={Lorrilliere, R},
+            url={http://www.vigienature.fr/sites/vigienature/files/atoms/files/analysestoceps_0.zip}
+            }
+            </citation>
+        </citations>
+    </xml>
+</macros>
--- /dev/null	Thu Jan 01 00:00:00 1970 +0000
+++ b/tabSpecies.csv	Thu Apr 02 03:35:29 2020 -0400
@@ -0,0 +1,325 @@
+"espece"	"nom"	"nomscientific"	"indicateur"	"specialisation"
+"ACCGEN"	"Autour des palombes"	"Accipiter gentilis"	FALSE	""
+"ACCNIS"	"Epervier d'Europe"	"Accipiter nisus"	FALSE	""
+"ACRARU"	"Rousserolle turdoïde"	"Acrocephalus arundinaceus"	FALSE	""
+"ACRMEL"	"Lusciniole à moustaches"	"Acrocephalus melanopogon"	FALSE	""
+"ACRPAL"	"Phragmite aquatique"	"Acrocephalus paludicola"	FALSE	""
+"ACRRIS"	"Rousserolle verderolle"	"Acrocephalus palustris"	FALSE	""
+"ACRSCH"	"Phragmite des joncs"	"Acrocephalus schoenobaenus"	FALSE	""
+"ACRSCI"	"Rousserolle effarvatte"	"Acrocephalus scirpaceus"	FALSE	""
+"ACTHYP"	"Chevalier guignette"	"Actitis hypoleucos"	FALSE	""
+"AEGCAU"	"Mésange à longue queue"	"Aegithalos caudatus"	FALSE	""
+"AEGFUN"	"Chouette de Tengmalm"	"Aegolius funereus"	FALSE	""
+"AIXGAL"	"Canard mandarin"	"Aix galericulata"	FALSE	""
+"AIXSPO"	"Canard carolin"	"Aix sponsa"	FALSE	""
+"ALAARV"	"Alouette des champs"	"Alauda arvensis"	TRUE	"milieux agricoles"
+"ALCATT"	"Martin-pêcheur d'Europe"	"Alcedo atthis"	FALSE	""
+"ALCTOR"	"Pingouin torda"	"Alca torda"	FALSE	""
+"ALEGRA"	"Perdrix bartavelle"	"Alectoris graeca"	FALSE	""
+"ALERUF"	"Perdrix rouge"	"Alectoris rufa"	TRUE	"milieux agricoles"
+"ALLALL"	"Mergule nain"	"Alle alle"	FALSE	""
+"ALOAEG"	"Ouette d'Egypte"	"Alopochen aegyptiaca"	FALSE	""
+"ANAACU"	"Canard pilet"	"Anas acuta"	FALSE	""
+"ANACLY"	"Canard souchet"	"Anas clypeata"	FALSE	""
+"ANACRE"	"Sarcelle d'hiver"	"Anas crecca"	FALSE	""
+"ANAPEN"	"Canard siffleur"	"Anas penelope"	FALSE	""
+"ANAPLA"	"Canard colvert"	"Anas platyrhynchos"	FALSE	""
+"ANAQUE"	"Sarcelle d'été"	"Anas querquedula"	FALSE	""
+"ANASTR"	"Canard chipeau"	"Anas strepera"	FALSE	""
+"ANSANS"	"Oie cendrée"	"Anser anser"	FALSE	""
+"ANSIND"	"Oie à tête barrée"	"Anser indicus"	FALSE	""
+"ANTCAM"	"Pipit rousseline"	"Anthus campestris"	TRUE	"milieux agricoles"
+"ANTCER"	"Pipit à gorge rousse"	"Anthus cervinus"	FALSE	""
+"ANTPET"	"Pipit maritime"	"Anthus petrosus"	FALSE	""
+"ANTPRA"	"Pipit farlouse"	"Anthus pratensis"	TRUE	"milieux agricoles"
+"ANTRIC"	"Pipit de Richard"	"Anthus richardi"	FALSE	""
+"ANTSPI"	"Pipit spioncelle"	"Anthus spinoletta"	FALSE	""
+"ANTTRI"	"Pipit des arbres"	"Anthus trivialis"	FALSE	""
+"APUAPU"	"Martinet noir"	"Apus apus"	TRUE	"milieux bâtis"
+"APUMEL"	"Martinet à ventre blanc"	"Apus melba"	FALSE	""
+"APUPAL"	"Martinet pâle"	"Apus pallidus"	FALSE	""
+"AQUCHR"	"Aigle royal"	"Aquila chrysaetos"	FALSE	""
+"ARDCIN"	"Héron cendré"	"Ardea cinerea"	FALSE	""
+"ARDPUR"	"Héron pourpré"	"Ardea purpurea"	FALSE	""
+"ARDRAL"	"Crabier chevelu"	"Ardeola ralloides"	FALSE	""
+"AREINT"	"Tournepierre à collier"	"Arenaria interpres"	FALSE	""
+"ASIFLA"	"Hibou des marais"	"Asio flammeus"	FALSE	""
+"ASIOTU"	"Hibou moyen-duc"	"Asio otus"	FALSE	""
+"ATHNOC"	"Chevêche d'Athéna"	"Athene noctua"	FALSE	""
+"AYTAFF"	"Fuligule à tête noire"	"Aythya affinis"	FALSE	""
+"AYTFER"	"Fuligule milouin"	"Aythya ferina"	FALSE	""
+"AYTFUL"	"Fuligule morillon"	"Aythya fuligula"	FALSE	""
+"AYTMAR"	"Fuligule milouinan"	"Aythya marila"	FALSE	""
+"BOMGAR"	"Jaseur boréal"	"Bombycilla garrulus"	FALSE	""
+"BONBON"	"Gélinotte des bois"	"Bonasa bonasia"	FALSE	""
+"BOTSTE"	"Butor étoilé"	"Botaurus stellaris"	FALSE	""
+"BRABER"	"Bernache cravant"	"Branta bernicla"	FALSE	""
+"BRACAN"	"Bernache du Canada"	"Branta canadensis"	FALSE	""
+"BRALEU"	"Bernache nonnette"	"Branta leucopsis"	FALSE	""
+"BUBBUB"	"Grand-duc d'Europe"	"Bubo bubo"	FALSE	""
+"BUBIBI"	"Héron garde-boeufs"	"Bubulcus ibis"	FALSE	""
+"BUROED"	"Oedicnème criard"	"Burhinus oedicnemus"	FALSE	""
+"BUTBUT"	"Buse variable"	"Buteo buteo"	TRUE	"milieux agricoles"
+"CALACU"	"Bécasseau à queue pointue"	"Calidris acuminata"	FALSE	""
+"CALALB"	"Bécasseau sanderling"	"Calidris alba"	FALSE	""
+"CALALP"	"Bécasseau variable"	"Calidris alpina"	FALSE	""
+"CALBRA"	"Alouette calandrelle"	"Calandrella brachydactyla"	FALSE	""
+"CALCAN"	"Bécasseau maubèche"	"Calidris canutus"	FALSE	""
+"CALMIN"	"Bécasseau minute"	"Calidris minuta"	FALSE	""
+"CAPEUR"	"Engoulevent d'Europe"	"Caprimulgus europaeus"	FALSE	""
+"CARCAN"	"Linotte mélodieuse"	"Carduelis cannabina"	TRUE	"milieux agricoles"
+"CARCAR"	"Chardonneret élégant"	"Carduelis carduelis"	TRUE	"milieux bâtis"
+"CARCHL"	"Verdier d'Europe"	"Carduelis chloris"	TRUE	"milieux bâtis"
+"CARFLA"	"Sizerin flammé"	"Carduelis flammea"	FALSE	""
+"CARHOR"	"Sizerin blanchâtre"	"Carduelis hornemanni"	FALSE	""
+"CARRIS"	"Linotte à bec jaune"	"Carduelis flavirostris"	FALSE	""
+"CARSPI"	"Tarin des aulnes"	"Carduelis spinus"	FALSE	""
+"CERBRA"	"Grimpereau des jardins"	"Certhia brachydactyla"	TRUE	"milieux forestiers"
+"CERFAM"	"Grimpereau des bois"	"Certhia familiaris"	TRUE	"milieux forestiers"
+"CETCET"	"Bouscarle de Cetti"	"Cettia cetti"	FALSE	""
+"CHAALE"	"Gravelot à collier interrompu"	"Charadrius alexandrinus"	FALSE	""
+"CHADUB"	"Petit Gravelot"	"Charadrius dubius"	FALSE	""
+"CHAHIA"	"Grand Gravelot"	"Charadrius hiaticula"	FALSE	""
+"CHLHYB"	"Guifette moustac"	"Chlidonias hybrida"	FALSE	""
+"CHLNIG"	"Guifette noire"	"Chlidonias niger"	FALSE	""
+"CICCIC"	"Cigogne blanche"	"Ciconia ciconia"	FALSE	""
+"CICNIG"	"Cigogne noire"	"Ciconia nigra"	FALSE	""
+"CINCIN"	"Cincle plongeur"	"Cinclus cinclus"	FALSE	""
+"CIRAER"	"Busard des roseaux"	"Circus aeruginosus"	FALSE	""
+"CIRCYA"	"Busard Saint-Martin"	"Circus cyaneus"	FALSE	""
+"CIRGAL"	"Circaète Jean-le-blanc"	"Circaetus gallicus"	FALSE	""
+"CIRMAC"	"Busard pâle"	"Circus macrourus"	FALSE	""
+"CIRPYG"	"Busard cendré"	"Circus pygargus"	FALSE	""
+"CISJUN"	"Cisticole des joncs"	"Cisticola juncidis"	FALSE	""
+"CLAGLA"	"Coucou geai"	"Clamator glandarius"	FALSE	""
+"COCCOC"	"Grosbec casse-noyaux"	"Coccothraustes coccothraustes"	TRUE	"milieux forestiers"
+"COLLIV"	"Pigeon biset"	"Columba livia"	FALSE	""
+"COLOEN"	"Pigeon colombin"	"Columba oenas"	FALSE	""
+"COLPAL"	"Pigeon ramier"	"Columba palumbus"	TRUE	"generaliste"
+"COLVIR"	"Colin de Virginie"	"Colinus virginianus"	FALSE	""
+"CORCOR"	"Corneille noire"	"Corvus corone"	TRUE	"generaliste"
+"CORFRU"	"Corbeau freux"	"Corvus frugilegus"	TRUE	"milieux agricoles"
+"CORGAR"	"Rollier d'Europe"	"Coracias garrulus"	FALSE	""
+"CORMON"	"Choucas des tours"	"Corvus monedula"	TRUE	"milieux bâtis"
+"CORRAX"	"Grand Corbeau"	"Corvus corax"	FALSE	""
+"COTCOT"	"Caille des blés"	"Coturnix coturnix"	TRUE	"milieux agricoles"
+"CRECRE"	"Râle des genêts"	"Crex crex"	FALSE	""
+"CUCCAN"	"Coucou gris"	"Cuculus canorus"	TRUE	"generaliste"
+"CYGATR"	"Cygne noir"	"Cygnus atratus"	FALSE	""
+"CYGOLO"	"Cygne tuberculé"	"Cygnus olor"	FALSE	""
+"DELURB"	"Hirondelle de fenêtre"	"Delichon urbicum"	TRUE	"milieux bâtis"
+"DENLEU"	"Pic à dos blanc"	"Dendrocopos leucotos"	FALSE	""
+"DENMAJ"	"Pic épeiche"	"Dendrocopos major"	TRUE	"milieux forestiers"
+"DENMED"	"Pic mar"	"Dendrocopos medius"	TRUE	"milieux forestiers"
+"DENMIN"	"Pic épeichette"	"Dendrocopos minor"	FALSE	""
+"DRYMAR"	"Pic noir"	"Dryocopus martius"	TRUE	"milieux forestiers"
+"EGRALB"	"Grande Aigrette"	"Ardea alba"	FALSE	""
+"EGRGAR"	"Aigrette garzette"	"Egretta garzetta"	FALSE	""
+"ELACAE"	"Elanion blanc"	"Elanus caeruleus"	FALSE	""
+"EMBAUR"	"Bruant auréole"	"Emberiza aureola"	FALSE	""
+"EMBCAE"	"Bruant cendrillard"	"Emberiza caesia"	FALSE	""
+"EMBCIA"	"Bruant fou"	"Emberiza cia"	FALSE	""
+"EMBCIR"	"Bruant zizi"	"Emberiza cirlus"	TRUE	"milieux agricoles"
+"EMBCIT"	"Bruant jaune"	"Emberiza citrinella"	TRUE	"milieux agricoles"
+"EMBHOR"	"Bruant ortolan"	"Emberiza hortulana"	FALSE	"milieux agricoles"
+"EMBLEU"	"Bruant à calotte blanche"	"Emberiza leucocephalos"	FALSE	""
+"EMBMEL"	"Bruant mélanocéphale"	"Emberiza melanocephala"	FALSE	""
+"EMBSCH"	"Bruant des roseaux"	"Emberiza schoeniclus"	FALSE	""
+"EREALP"	"Alouette hausse-col"	"Eremophila alpestris"	FALSE	""
+"ERIRUB"	"Rougegorge familier"	"Erithacus rubecula"	TRUE	"milieux forestiers"
+"EUOMAL"	"Capucin bec-de-plomb"	"Euodice malabarica"	FALSE	""
+"FALCOL"	"Faucon émerillon"	"Falco columbarius"	FALSE	""
+"FALNAU"	"Faucon crécerellette"	"Falco naumanni"	FALSE	""
+"FALPER"	"Faucon pèlerin"	"Falco peregrinus"	FALSE	""
+"FALSUB"	"Faucon hobereau"	"Falco subbuteo"	FALSE	""
+"FALTIN"	"Faucon crécerelle"	"Falco tinnunculus"	TRUE	"milieux agricoles"
+"FALVES"	"Faucon kobez"	"Falco vespertinus"	FALSE	""
+"FICALB"	"Gobemouche à collier"	"Ficedula albicollis"	FALSE	""
+"FICHYP"	"Gobemouche noir"	"Ficedula hypoleuca"	FALSE	""
+"FICPAR"	"Gobemouche nain"	"Ficedula parva"	FALSE	""
+"FRAARC"	"Macareux moine"	"Fratercula arctica"	FALSE	""
+"FRICOE"	"Pinson des arbres"	"Fringilla coelebs"	TRUE	"generaliste"
+"FRIMON"	"Pinson du Nord"	"Fringilla montifringilla"	FALSE	""
+"FULATR"	"Foulque macroule"	"Fulica atra"	FALSE	""
+"FULCRI"	"Foulque caronculée"	"Fulica cristata"	FALSE	""
+"GALCHL"	"Gallinule poule-d'eau"	"Gallinula chloropus"	FALSE	""
+"GALCRI"	"Cochevis huppé"	"Galerida cristata"	TRUE	"milieux agricoles"
+"GALGAL"	"Bécassine des marais"	"Gallinago gallinago"	FALSE	""
+"GALTHE"	"Cochevis de Thékla"	"Galerida theklae"	FALSE	""
+"GARGLA"	"Geai des chênes"	"Garrulus glandarius"	TRUE	"generaliste"
+"GLAPAS"	"Chevêchette d'Europe"	"Glaucidium passerinum"	FALSE	""
+"GRUGRU"	"Grue cendrée"	"Grus grus"	FALSE	""
+"GYPFUL"	"Vautour fauve"	"Gyps fulvus"	FALSE	""
+"HAEOST"	"Huîtrier pie"	"Haematopus ostralegus"	FALSE	""
+"HIEFAS"	"Aigle de Bonelli"	"Aquila fasciata"	FALSE	""
+"HIEPEN"	"Aigle botté"	"Hieraaetus pennatus"	FALSE	""
+"HIMHIM"	"Echasse blanche"	"Himantopus himantopus"	FALSE	""
+"HIPICT"	"Hypolaïs ictérine"	"Hippolais icterina"	FALSE	""
+"HIPPAL"	"Hypolaïs pâle"	"Iduna pallida"	FALSE	""
+"HIPPOL"	"Hypolaïs polyglotte"	"Hippolais polyglotta"	TRUE	"generaliste"
+"HIRDAU"	"Hirondelle rousseline"	"Cecropis daurica"	FALSE	""
+"HIRRUS"	"Hirondelle rustique"	"Hirundo rustica"	TRUE	"milieux bâtis"
+"IXOMIN"	"Blongios nain"	"Ixobrychus minutus"	FALSE	""
+"JYNTOR"	"Torcol fourmilier"	"Jynx torquilla"	FALSE	""
+"LAGLAG"	"Lagopède des saules"	"Lagopus lagopus"	FALSE	""
+"LAGMUT"	"Lagopède alpin"	"Lagopus muta"	FALSE	""
+"LANCOL"	"Pie-grièche écorcheur"	"Lanius collurio"	TRUE	"milieux agricoles"
+"LANEXC"	"Pie-grièche grise"	"Lanius excubitor"	FALSE	""
+"LANMER"	"Pie-grièche méridionale"	"Lanius meridionalis"	FALSE	""
+"LANMIN"	"Pie-grièche à poitrine rose"	"Lanius minor"	FALSE	""
+"LANSEN"	"Pie-grièche à tête rousse"	"Lanius senator"	FALSE	""
+"LARARG"	"Goéland argenté"	"Larus argentatus"	FALSE	""
+"LARCAN"	"Goéland cendré"	"Larus canus"	FALSE	""
+"LARFUS"	"Goéland brun"	"Larus fuscus"	FALSE	""
+"LARGEN"	"Goéland railleur"	"Chroicocephalus genei"	FALSE	""
+"LARMAR"	"Goéland marin"	"Larus marinus"	FALSE	""
+"LARMEL"	"Mouette mélanocéphale"	"Ichthyaetus melanocephalus"	FALSE	""
+"LARMIC"	"Goéland leucophée"	"Larus michahellis"	FALSE	""
+"LARRID"	"Mouette rieuse"	"Chroicocephalus ridibundus"	FALSE	""
+"LEILUT"	"Leïothrix jaune"	"Leiothrix lutea"	FALSE	""
+"LIMLAP"	"Barge rousse"	"Limosa lapponica"	FALSE	""
+"LIMLIM"	"Barge à queue noire"	"Limosa limosa"	FALSE	""
+"LOCFLU"	"Locustelle fluviatile"	"Locustella fluviatilis"	FALSE	""
+"LOCLUS"	"Locustelle luscinioïde"	"Locustella luscinioides"	FALSE	""
+"LOCNAE"	"Locustelle tachetée"	"Locustella naevia"	FALSE	""
+"LOXCUR"	"Bec-croisé des sapins"	"Loxia curvirostra"	FALSE	""
+"LOXLEU"	"Bec-croisé bifascié"	"Loxia leucoptera"	FALSE	""
+"LULARB"	"Alouette lulu"	"Lullula arborea"	TRUE	"milieux agricoles"
+"LUSLUS"	"Rossignol progné"	"Luscinia luscinia"	FALSE	""
+"LUSMEG"	"Rossignol philomèle"	"Luscinia megarhynchos"	TRUE	"generaliste"
+"LUSSVE"	"Gorgebleue à miroir"	"Luscinia svecica"	FALSE	""
+"MARANG"	"Sarcelle marbrée"	"Marmaronetta angustirostris"	FALSE	""
+"MELCAL"	"Alouette calandre"	"Melanocorypha calandra"	FALSE	""
+"MERALB"	"Harle piette"	"Mergellus albellus"	FALSE	""
+"MERAPI"	"Guêpier d'Europe"	"Merops apiaster"	FALSE	""
+"MERMER"	"Harle bièvre"	"Mergus merganser"	FALSE	""
+"MILCAL"	"Bruant proyer"	"Emberiza calandra"	TRUE	"milieux agricoles"
+"MILMIG"	"Milan noir"	"Milvus migrans"	FALSE	""
+"MILMIL"	"Milan royal"	"Milvus milvus"	FALSE	""
+"MONNIV"	"Niverolle alpine"	"Montifringilla nivalis"	FALSE	""
+"MONSAX"	"Monticole de roche"	"Monticola saxatilis"	FALSE	""
+"MONSOL"	"Monticole bleu"	"Monticola solitarius"	FALSE	""
+"MOTALB"	"Bergeronnette grise"	"Motacilla alba"	FALSE	""
+"MOTCIN"	"Bergeronnette des ruisseaux"	"Motacilla cinerea"	FALSE	""
+"MOTFLA"	"Bergeronnette printanière"	"Motacilla flava"	TRUE	"milieux agricoles"
+"MUSSTR"	"Gobemouche gris"	"Muscicapa striata"	FALSE	""
+"NEOPER"	"Vautour percnoptère"	"Neophron percnopterus"	FALSE	""
+"NETRUF"	"Nette rousse"	"Netta rufina"	FALSE	""
+"NUCCAR"	"Cassenoix moucheté"	"Nucifraga caryocatactes"	FALSE	""
+"NUMARQ"	"Courlis cendré"	"Numenius arquata"	FALSE	""
+"NUMPHA"	"Courlis corlieu"	"Numenius phaeopus"	FALSE	""
+"NYCNYC"	"Bihoreau gris"	"Nycticorax nycticorax"	FALSE	""
+"OCELEU"	"Océanite culblanc"	"Oceanodroma leucorhoa"	FALSE	""
+"OENHIS"	"Traquet oreillard"	"Oenanthe hispanica"	FALSE	""
+"OENOEN"	"Traquet motteux"	"Oenanthe oenanthe"	TRUE	"milieux agricoles"
+"OENPLE"	"Traquet pie"	"Oenanthe pleschanka"	FALSE	""
+"ORIORI"	"Loriot d'Europe"	"Oriolus oriolus"	TRUE	"generaliste"
+"OTUSCO"	"Petit-duc scops"	"Otus scops"	FALSE	""
+"PANBIA"	"Panure à moustaches"	"Panurus biarmicus"	FALSE	""
+"PANHAL"	"Balbuzard pêcheur"	"Pandion haliaetus"	FALSE	""
+"PARATE"	"Mésange noire"	"Periparus ater"	TRUE	"milieux forestiers"
+"PARCAE"	"Mésange bleue"	"Cyanistes caeruleus"	TRUE	"generaliste"
+"PARCRI"	"Mésange huppée"	"Lophophanes cristatus"	TRUE	"milieux forestiers"
+"PARCYA"	"Mésange azurée"	"Parus cyanus"	FALSE	""
+"PARLUG"	"Mésange lugubre"	"Poecile lugubris"	FALSE	""
+"PARMAJ"	"Mésange charbonnière"	"Parus major"	TRUE	"generaliste"
+"PARMON"	"Mésange boréale"	"Parus montanus"	FALSE	""
+"PARPAL"	"Mésange nonnette"	"Poecile palustris"	TRUE	"milieux forestiers"
+"PASDOM"	"Moineau domestique"	"Passer domesticus"	TRUE	"milieux bâtis"
+"PASHIS"	"Moineau espagnol"	"Passer hispaniolensis"	FALSE	""
+"PASITA"	"Moineau cisalpin"	"Passer italiae"	FALSE	""
+"PASMON"	"Moineau friquet"	"Passer montanus"	TRUE	"milieux bâtis"
+"PERAPI"	"Bondrée apivore"	"Pernis apivorus"	FALSE	""
+"PERPER"	"Perdrix grise"	"Perdix perdix"	TRUE	"milieux agricoles"
+"PETPET"	"Moineau soulcie"	"Petronia petronia"	FALSE	""
+"PHACAR"	"Grand Cormoran"	"Phalacrocorax carbo"	FALSE	""
+"PHACOL"	"Faisan de Colchide"	"Phasianus colchicus"	FALSE	""
+"PHIPUG"	"Combattant varié"	"Calidris pugnax"	FALSE	""
+"PHOCHI"	"Flamant du Chili"	"Phoenicopterus chilensis"	FALSE	""
+"PHOOCH"	"Rougequeue noir"	"Phoenicurus ochruros"	TRUE	"milieux bâtis"
+"PHOPHO"	"Rougequeue à front blanc"	"Phoenicurus phoenicurus"	TRUE	"milieux bâtis"
+"PHORUB"	"Flamant rose"	"Phoenicopterus roseus"	FALSE	""
+"PHYBON"	"Pouillot de Bonelli"	"Phylloscopus bonelli"	TRUE	"milieux forestiers"
+"PHYBOR"	"Pouillot boréal"	"Phylloscopus borealis"	FALSE	""
+"PHYCOL"	"Pouillot véloce"	"Phylloscopus collybita"	TRUE	"milieux forestiers"
+"PHYSIB"	"Pouillot siffleur"	"Phylloscopus sibilatrix"	TRUE	"milieux forestiers"
+"PHYTRO"	"Pouillot fitis"	"Phylloscopus trochilus"	TRUE	"milieux forestiers"
+"PICCAN"	"Pic cendré"	"Picus canus"	TRUE	"milieux forestiers"
+"PICPIC"	"Pie bavarde"	"Pica pica"	TRUE	"milieux bâtis"
+"PICTRI"	"Pic tridactyle"	"Picoides tridactylus"	FALSE	""
+"PICVIR"	"Pic vert"	"Picus viridis"	TRUE	"generaliste"
+"PLALEU"	"Spatule blanche"	"Platalea leucorodia"	FALSE	""
+"PLEFAL"	"Ibis falcinelle"	"Plegadis falcinellus"	FALSE	""
+"PLUAPR"	"Pluvier doré"	"Pluvialis apricaria"	FALSE	""
+"PLUSQU"	"Pluvier argenté"	"Pluvialis squatarola"	FALSE	""
+"PODCRI"	"Grèbe huppé"	"Podiceps cristatus"	FALSE	""
+"PORPOR"	"Marouette ponctuée"	"Porzana porzana"	FALSE	""
+"PRUCOL"	"Accenteur alpin"	"Prunella collaris"	FALSE	""
+"PRUMOD"	"Accenteur mouchet"	"Prunella modularis"	TRUE	"generaliste"
+"PSIKRA"	"Perruche à collier"	"Psittacula krameri"	FALSE	""
+"PTYRUP"	"Hirondelle de rochers"	"Ptyonoprogne rupestris"	FALSE	""
+"PYRGRA"	"Chocard à bec jaune"	"Pyrrhocorax graculus"	FALSE	""
+"PYRPYR"	"Bouvreuil pivoine"	"Pyrrhula pyrrhula"	TRUE	"milieux forestiers"
+"PYRRAX"	"Crave à bec rouge"	"Pyrrhocorax pyrrhocorax"	FALSE	""
+"RALAQU"	"Râle d'eau"	"Rallus aquaticus"	FALSE	""
+"RECAVO"	"Avocette élégante"	"Recurvirostra avosetta"	FALSE	""
+"REGIGN"	"Roitelet à triple bandeau"	"Regulus ignicapilla"	TRUE	"milieux forestiers"
+"REGREG"	"Roitelet huppé"	"Regulus regulus"	TRUE	"milieux forestiers"
+"RIPRIP"	"Hirondelle de rivage"	"Riparia riparia"	FALSE	""
+"SAXRUB"	"Tarier des prés"	"Saxicola rubetra"	TRUE	"milieux agricoles"
+"SAXTOR"	"Tarier pâtre"	"Saxicola rubicola"	TRUE	"milieux agricoles"
+"SCORUS"	"Bécasse des bois"	"Scolopax rusticola"	FALSE	""
+"SERCIT"	"Venturon montagnard"	"Serinus citrinella"	FALSE	""
+"SERCOR"	"Venturon corse"	"Serinus corsicanus"	FALSE	""
+"SERSER"	"Serin cini"	"Serinus serinus"	TRUE	"milieux bâtis"
+"SITEUR"	"Sittelle torchepot"	"Sitta europaea"	TRUE	"milieux forestiers"
+"SITWHI"	"Sittelle corse"	"Sitta whiteheadi"	FALSE	""
+"STEALB"	"Sterne naine"	"Sternula albifrons"	FALSE	""
+"STEHIR"	"Sterne pierregarin"	"Sterna hirundo"	FALSE	""
+"STESAN"	"Sterne caugek"	"Thalasseus sandvicensis"	FALSE	""
+"STRALU"	"Chouette hulotte"	"Strix aluco"	FALSE	""
+"STRDEC"	"Tourterelle turque"	"Streptopelia decaocto"	TRUE	"milieux bâtis"
+"STRORI"	"Tourterelle orientale"	"Streptopelia orientalis"	FALSE	""
+"STRSEN"	"Tourterelle maillée"	"Streptopelia senegalensis"	FALSE	""
+"STRTUR"	"Tourterelle des bois"	"Streptopelia turtur"	FALSE	""
+"STUROS"	"Étourneau roselin"	"Sturnus roseus"	FALSE	""
+"STUUNI"	"Étourneau unicolore"	"Sturnus unicolor"	FALSE	""
+"STUVUL"	"Étourneau sansonnet"	"Sturnus vulgaris"	FALSE	""
+"SURULU"	"Chouette épervière"	"Surnia ulula"	FALSE	""
+"SYLATR"	"Fauvette à tête noire"	"Sylvia atricapilla"	TRUE	"generaliste"
+"SYLBOR"	"Fauvette des jardins"	"Sylvia borin"	FALSE	""
+"SYLCAN"	"Fauvette passerinette"	"Sylvia cantillans"	FALSE	""
+"SYLCOM"	"Fauvette grisette"	"Sylvia communis"	TRUE	"milieux agricoles"
+"SYLCON"	"Fauvette à lunettes"	"Sylvia conspicillata"	FALSE	""
+"SYLCUR"	"Fauvette babillarde"	"Sylvia curruca"	FALSE	""
+"SYLHOR"	"Fauvette orphée"	"Sylvia hortensis"	FALSE	""
+"SYLMEL"	"Fauvette mélanocéphale"	"Sylvia melanocephala"	TRUE	"milieux forestiers"
+"SYLNIS"	"Fauvette épervière"	"Sylvia nisoria"	FALSE	""
+"SYLSAR"	"Fauvette sarde"	"Sylvia sarda"	FALSE	""
+"SYLUND"	"Fauvette pitchou"	"Sylvia undata"	FALSE	""
+"SYRREE"	"Faisan vénéré"	"Syrmaticus reevesii"	FALSE	""
+"TACRUF"	"Grèbe castagneux"	"Tachybaptus ruficollis"	FALSE	""
+"TADFER"	"Tadorne casarca"	"Tadorna ferruginea"	FALSE	""
+"TADTAD"	"Tadorne de Belon"	"Tadorna tadorna"	FALSE	""
+"TETRAX"	"Outarde canepetière"	"Tetrax tetrax"	FALSE	""
+"TETRIX"	"Tétras lyre"	"Tetrao tetrix"	FALSE	""
+"TETURO"	"Grand Tétras"	"Tetrao urogallus"	FALSE	""
+"THRAET"	"Ibis sacré"	"Threskiornis aethiopicus"	FALSE	""
+"TICMUR"	"Tichodrome échelette"	"Tichodroma muraria"	FALSE	""
+"TRIERY"	"Chevalier arlequin"	"Tringa erythropus"	FALSE	""
+"TRIGLA"	"Chevalier sylvain"	"Tringa glareola"	FALSE	""
+"TRINEB"	"Chevalier aboyeur"	"Tringa nebularia"	FALSE	""
+"TRIOCH"	"Chevalier culblanc"	"Tringa ochropus"	FALSE	""
+"TRITOT"	"Chevalier gambette"	"Tringa totanus"	FALSE	""
+"TROTRO"	"Troglodyte mignon"	"Troglodytes troglodytes"	TRUE	"milieux forestiers"
+"TURILI"	"Grive mauvis"	"Turdus iliacus"	FALSE	""
+"TURMER"	"Merle noir"	"Turdus merula"	TRUE	"generaliste"
+"TURPHI"	"Grive musicienne"	"Turdus philomelos"	TRUE	"milieux forestiers"
+"TURPIL"	"Grive litorne"	"Turdus pilaris"	FALSE	""
+"TURRUF"	"Grive à gorge noire ou rousse"	"Turdus ruficollis"	FALSE	""
+"TURTOR"	"Merle à plastron"	"Turdus torquatus"	FALSE	""
+"TURVIS"	"Grive draine"	"Turdus viscivorus"	TRUE	"milieux forestiers"
+"TYTALB"	"Effraie des clochers"	"Tyto alba"	FALSE	""
+"UPUEPO"	"Huppe fasciée"	"Upupa epops"	TRUE	"milieux agricoles"
+"VANVAN"	"Vanneau huppé"	"Vanellus vanellus"	TRUE	"milieux agricoles"
+"ZOODAU"	"Grive dorée"	"Zoothera dauma"	FALSE	""
--- /dev/null	Thu Jan 01 00:00:00 1970 +0000
+++ b/temp_analysis_indic.xml	Thu Apr 02 03:35:29 2020 -0400
@@ -0,0 +1,209 @@
+<tool id="stoceps_trend_indic" name="Temporal trend indicator" version="@VERSION@">
+    <description>using GlmmTMB or GAM models</description>
+    <macros>
+        <import>stoceps_macros.xml</import>
+    </macros>
+    <expand macro="temp_indic_requirements"/>
+    <command detect_errors="exit_code"><![CDATA[
+        Rscript 
+         '$__tool_directory__/FunctExeTemporalAnalysisofIndicatorTrait.r' 
+         '$input'
+         '$inputtabSpecies'
+         '$inputspeciesindic'
+         '$inputcoord'
+         #if $index=='csi' 
+             'ssi'
+             'csi'
+         #elif $index=='cti'
+             'sti'
+             'cti'
+         #else
+             'stri'
+             'ctri'
+         #end if
+         #if $settings.advanced=='advanced' 
+             $settings.method '' 'idindicatortrait'
+             $settings.smooth_plot
+             $settings.compute_ic
+         #else
+             'gam' '' 'idindicatortrait'
+             'TRUE'
+             'TRUE'
+         #end if
+         '$__tool_directory__/FunctTrendSTOCGalaxy.r' 
+    ]]>
+    </command>
+    <inputs>
+        <expand macro="stoceps_input_filtered"/>
+        <param name="inputcoord" type="data" format="tabular" label="Coordinates of sites" help="Input localization tabular file, with 3 columns (site ID, latitude, longitude)." />
+        <param name="inputtabSpecies" type="data" format="tabular" label="Species file" help="Input species tabular file, with 5 columns (species ID, species name, species scientific name, specialization status)." />
+        <param name="inputspeciesindic" type="data" format="tabular" label="indicators info file" help="Input indicator info tabular file, with a `species ID` column and at least one index column (named `ssi` or `sti` or `stri`)." />
+        <param name="index" type="select" help="Available index" label="Chose the index you want to compute">
+            <option selected="true" value="csi">CSI</option>
+            <option value="cti">CTI</option>
+            <option value="ctri">CTRI</option>
+        </param>
+        <conditional name="settings">
+            <expand macro="stoceps_advanced_params_select"/>
+            <when value="advanced">
+                <param name="smooth_plot" type="boolean" truevalue="TRUE" falsevalue="FALSE" checked="yes" label="Smooth visualization."/>
+                <param name="method" type="select" help="Available methods are GlmmTMB and Gam" label="Chose the model method">
+                    <option selected="true" value="glmmtmb">GlmmTMB</option>
+                    <option value="gam">Gam</option>
+                </param>
+                <expand macro="stoceps_compute_ic"/>
+            </when>
+        </conditional>
+    </inputs>
+    <outputs>
+        <data name="output_tab_gammcomplet" from_work_dir="Output/csi_gammCOMPLET_France.tabular" format="tabular" label="GAM - Temp trends all data - on ${on_string}">
+            <expand macro="stoceps_filter_gam"/>
+        </data>
+        <data name="output_tab_gam_annee" from_work_dir="Output/csi_gammParannee_France.tabular" format="tabular" label="GAM - Temp trends per year - on ${on_string}">
+            <expand macro="stoceps_filter_gam"/>
+        </data>
+        <data name="output_plot_carre" from_work_dir="Output/figcsi_carre_France.png" format="png" label="GAM - Temp trends plot on ${on_string}">
+            <expand macro="stoceps_filter_gam"/>
+        </data>
+        <data name="output_plot__gam_csiplot" from_work_dir="Output/figcsi_plotFrance.png" format="png" label="GAM - Temp trends plot on ${on_string}">
+            <expand macro="stoceps_filter_gam"/>
+        </data>
+        <data name="output_tab_gam_smoothed" from_work_dir="Output/csi_gammsmoothFrance.tabular" format="tabular" label="GAM - Temp trends smoothed data on ${on_string}">
+            <expand macro="stoceps_filter_gam"/>
+        </data>
+        
+        <data name="output_plot_glmmtb_csiplot" from_work_dir="Output/csi_glmmTMB_France.png" format="png" label="GlmmTMB - Temp trends plot on ${on_string}">
+            <expand macro="stoceps_filter_glmmtmb"/>
+        </data>
+        <data name="output_tab_glmmtb_annee" from_work_dir="Output/ggdata_csiFrance.tabular" format="tabular" label="GlmmTMB - Temp trends per year - on ${on_string}">
+            <expand macro="stoceps_filter_glmmtmb"/>
+        </data>
+        <data name="output_tab_glmmtb_gammcomplet" from_work_dir="Output/GlmmTMB_coefficient_csiFrance.tabular" format="tabular" label="GlmmTMB - Temp trends per year - on ${on_string}">
+            <expand macro="stoceps_filter_glmmtmb"/>
+        </data>
+    </outputs>
+    <tests>
+        <test>
+            <param name="input" value="data_FrenchBBS_squarre_dataSTOCallSp_France_trend_2001_2017_ALAARV-PARCAE_2001_2018.tabular"/>
+            <param name="inputcoord" value="coordCarreSTOCfaux.tabular"/>
+            <param name="inputspeciesindic" value="species_indicateur_fonctionnel.tabular"/>
+            <param name="inputtabSpecies" value="tabSpecies.csv"/>
+            <param name="advanced" value="advanced"/>
+            <param name="smooth_plot" value="TRUE"/>
+            <param name="method" value="gam"/>
+            <param name="compute_ic" value="FALSE"/>
+            <output name="output_tab_gammcomplet">
+                <assert_contents>
+                    <has_n_lines n="20"/>
+                    <has_size value="3500" delta="100"/>
+                </assert_contents>
+            </output>
+            <output name="output_tab_gam_annee">
+                <assert_contents>
+                    <has_n_lines n="19"/>
+                    <has_size value="2400" delta="100"/>
+                </assert_contents>
+            </output>
+            <output name="output_tab_gam_smoothed">
+                <assert_contents>
+                    <has_n_lines n="19"/>
+                    <has_size value="1200" delta="50"/>
+                </assert_contents>
+            </output>
+            <output name="output_plot_carre">
+                <assert_contents>
+                    <has_text text="PNG"/>
+                </assert_contents>
+            </output>
+            <output name="output_plot__gam_csiplot">
+                <assert_contents>
+                    <has_text text="PNG"/>
+                </assert_contents>
+            </output>
+        </test>
+        <test>
+            <param name="input" value="Datafilteredfortrendanalysis.tabular"/>
+            <param name="inputcoord" value="coordCarreSTOCfaux.tabular"/>
+            <param name="inputspeciesindic" value="species_indicateur_fonctionnel.tabular"/>
+            <param name="inputtabSpecies" value="tabSpecies.csv"/>
+            <param name="advanced" value="advanced"/>
+            <param name="smooth_plot" value="FALSE"/>
+            <param name="method" value="glmmtmb"/>
+            <param name="compute_ic" value="TRUE"/>
+            <output name="output_plot_glmmtb_csiplot">
+                <assert_contents>
+                    <has_text text="PNG"/>
+                </assert_contents>
+            </output>
+            <output name="output_tab_glmmtb_annee">
+                <assert_contents>
+                    <has_n_lines n="18"/>
+                    <has_size value="1400" delta="50"/>
+                </assert_contents>
+            </output>
+            <output name="output_tab_glmmtb_gammcomplet">
+                <assert_contents>
+                    <has_n_lines n="19"/>
+                    <has_size value="2900" delta="100"/>
+                </assert_contents>
+            </output>
+        </test>
+    </tests>
+    <help><![CDATA[
+=================================================
+STOC Temporal population trend indicator
+=================================================
+
+**What it does**
+
+Compute and plot time variation of indicator or mean trait values of communities.
+
+CSI Temporal analysis indicator
+This script computes the indicator csi, cti and ctri per year and site, wich also correspond to a community weighted mean (CWM), and analyse its temporal evolution trend and create graphical vizualisation.
+As indicator you can thus use also a trait.
+
+|
+
+**Input description**
+
+A tabular file with count data including one column for the abundance, one column indicating the species, one indicating the site and one indicating the year
+that could be extracted from the STOC on demand: romain.lorrilliere@mnhn.fr 
+
+IMPORTANT: The tabular file with the count data should not include zero count because this will biais the estimation of the weighted mean.
+In the same line, the species trait data should be complete or you should remove the species without trait value from your count data file.  
+
+One tabular species file, with a `species ID` column and species names.
+
+One tabular file with trait data including at least one column with the species name or ID (the one used in the count data file) and one column with the trait value for each species (named `ssi` or `sti` or `stri`). For the CSI indicator notably (community specialization index), this should be the ssi (species specialization index).   
+
+One tabular file with coordinates in latitude and longitude (one column for each) including also the site ID (the one used in the count data file) 
+
+|
+
+**Output**
+
+Gam method ::
+
+ - Two tabulars that details computed indicator per year and globaly and one optional and additional table with the smoothed data.
+
+ - One plot that show trends across years and one optional and additional plot with the smooth method.
+
+|
+
+GlmmTMB method ::
+
+ - Two tabulars that details computed indicator per year and globaly.
+
+ - A plot that show trends across years.
+
+
+|
+
+**Source**
+
+UnPublished script available at http://www.vigienature.fr/sites/vigienature/files/atoms/files/analysestoceps_0.zip
+and the first version written by Romain Lorrilliere
+
+  ]]></help>
+  <expand macro="stoceps_bibref" />
+</tool>